Fix #include style issues
authorTeemu Murtola <teemu.murtola@gmail.com>
Mon, 9 Dec 2013 19:32:35 +0000 (21:32 +0200)
committerGerrit Code Review <gerrit@gerrit.gromacs.org>
Sat, 4 Jan 2014 00:22:52 +0000 (01:22 +0100)
Include local headers as "something.h" instead of <something.h>, and
vice versa for system headers.  These locations were found while working
on the includedeps.py script; it is easier to fix them than try to
selectively suppress things in the script.

All changes under linearalgebra are mechanical replacements of
  #include <types/simple.h>
with
  #include "types/simple.h"
Other files contain various fixes.  Removed includes for sysstuff.h,
since it doesn't serve a very useful purpose.

Deleted displacement.c and displacement.h instead of fixing, as they
have not been compiled in a long time.

Change-Id: I06e04c74707621903a1fa79de060e1989b99f042

114 files changed:
src/gromacs/gmxana/expfit.c
src/gromacs/gmxana/gmx_helixorient.c
src/gromacs/gmxlib/gmx_detect_hardware.c
src/gromacs/gmxlib/gmx_fatal.c
src/gromacs/gmxlib/gmx_random.c
src/gromacs/gmxlib/maths.c
src/gromacs/gmxlib/mvdata.c
src/gromacs/gmxlib/smalloc.c
src/gromacs/gmxlib/statistics/histogram.c
src/gromacs/gmxlib/thread_mpi/numa_malloc.c
src/gromacs/gmxlib/trajana/displacement.c [deleted file]
src/gromacs/gmxlib/warninp.c
src/gromacs/legacyheaders/displacement.h [deleted file]
src/gromacs/linearalgebra/gmx_blas/dgemm.c
src/gromacs/linearalgebra/gmx_blas/dgemv.c
src/gromacs/linearalgebra/gmx_blas/dger.c
src/gromacs/linearalgebra/gmx_blas/dnrm2.c
src/gromacs/linearalgebra/gmx_blas/dsymv.c
src/gromacs/linearalgebra/gmx_blas/dsyr2.c
src/gromacs/linearalgebra/gmx_blas/dsyr2k.c
src/gromacs/linearalgebra/gmx_blas/dtrmm.c
src/gromacs/linearalgebra/gmx_blas/dtrmv.c
src/gromacs/linearalgebra/gmx_blas/dtrsm.c
src/gromacs/linearalgebra/gmx_blas/sgemm.c
src/gromacs/linearalgebra/gmx_blas/sgemv.c
src/gromacs/linearalgebra/gmx_blas/sger.c
src/gromacs/linearalgebra/gmx_blas/snrm2.c
src/gromacs/linearalgebra/gmx_blas/ssymv.c
src/gromacs/linearalgebra/gmx_blas/ssyr2.c
src/gromacs/linearalgebra/gmx_blas/ssyr2k.c
src/gromacs/linearalgebra/gmx_blas/strmm.c
src/gromacs/linearalgebra/gmx_blas/strmv.c
src/gromacs/linearalgebra/gmx_blas/strsm.c
src/gromacs/linearalgebra/gmx_lapack/dbdsdc.c
src/gromacs/linearalgebra/gmx_lapack/dbdsqr.c
src/gromacs/linearalgebra/gmx_lapack/dgesdd.c
src/gromacs/linearalgebra/gmx_lapack/dgetf2.c
src/gromacs/linearalgebra/gmx_lapack/dlaed6.c
src/gromacs/linearalgebra/gmx_lapack/dlaev2.c
src/gromacs/linearalgebra/gmx_lapack/dlagtf.c
src/gromacs/linearalgebra/gmx_lapack/dlagts.c
src/gromacs/linearalgebra/gmx_lapack/dlapy2.c
src/gromacs/linearalgebra/gmx_lapack/dlar1vx.c
src/gromacs/linearalgebra/gmx_lapack/dlarf.c
src/gromacs/linearalgebra/gmx_lapack/dlarfg.c
src/gromacs/linearalgebra/gmx_lapack/dlarft.c
src/gromacs/linearalgebra/gmx_lapack/dlarrbx.c
src/gromacs/linearalgebra/gmx_lapack/dlarrex.c
src/gromacs/linearalgebra/gmx_lapack/dlarrfx.c
src/gromacs/linearalgebra/gmx_lapack/dlarrvx.c
src/gromacs/linearalgebra/gmx_lapack/dlartg.c
src/gromacs/linearalgebra/gmx_lapack/dlas2.c
src/gromacs/linearalgebra/gmx_lapack/dlascl.c
src/gromacs/linearalgebra/gmx_lapack/dlasd2.c
src/gromacs/linearalgebra/gmx_lapack/dlasd4.c
src/gromacs/linearalgebra/gmx_lapack/dlasd7.c
src/gromacs/linearalgebra/gmx_lapack/dlasq1.c
src/gromacs/linearalgebra/gmx_lapack/dlasq2.c
src/gromacs/linearalgebra/gmx_lapack/dlasq3.c
src/gromacs/linearalgebra/gmx_lapack/dlasq4.c
src/gromacs/linearalgebra/gmx_lapack/dlasq6.c
src/gromacs/linearalgebra/gmx_lapack/dlasr.c
src/gromacs/linearalgebra/gmx_lapack/dlassq.c
src/gromacs/linearalgebra/gmx_lapack/dlasv2.c
src/gromacs/linearalgebra/gmx_lapack/dorml2.c
src/gromacs/linearalgebra/gmx_lapack/dstebz.c
src/gromacs/linearalgebra/gmx_lapack/dstegr.c
src/gromacs/linearalgebra/gmx_lapack/dstein.c
src/gromacs/linearalgebra/gmx_lapack/dsteqr.c
src/gromacs/linearalgebra/gmx_lapack/dsterf.c
src/gromacs/linearalgebra/gmx_lapack/dsyevr.c
src/gromacs/linearalgebra/gmx_lapack/dsytd2.c
src/gromacs/linearalgebra/gmx_lapack/dtrtri.c
src/gromacs/linearalgebra/gmx_lapack/sbdsdc.c
src/gromacs/linearalgebra/gmx_lapack/sbdsqr.c
src/gromacs/linearalgebra/gmx_lapack/sgesdd.c
src/gromacs/linearalgebra/gmx_lapack/sgetf2.c
src/gromacs/linearalgebra/gmx_lapack/slaed6.c
src/gromacs/linearalgebra/gmx_lapack/slaev2.c
src/gromacs/linearalgebra/gmx_lapack/slagtf.c
src/gromacs/linearalgebra/gmx_lapack/slagts.c
src/gromacs/linearalgebra/gmx_lapack/slapy2.c
src/gromacs/linearalgebra/gmx_lapack/slar1vx.c
src/gromacs/linearalgebra/gmx_lapack/slarf.c
src/gromacs/linearalgebra/gmx_lapack/slarfg.c
src/gromacs/linearalgebra/gmx_lapack/slarft.c
src/gromacs/linearalgebra/gmx_lapack/slarrbx.c
src/gromacs/linearalgebra/gmx_lapack/slarrex.c
src/gromacs/linearalgebra/gmx_lapack/slarrfx.c
src/gromacs/linearalgebra/gmx_lapack/slarrvx.c
src/gromacs/linearalgebra/gmx_lapack/slartg.c
src/gromacs/linearalgebra/gmx_lapack/slas2.c
src/gromacs/linearalgebra/gmx_lapack/slascl.c
src/gromacs/linearalgebra/gmx_lapack/slasd2.c
src/gromacs/linearalgebra/gmx_lapack/slasd4.c
src/gromacs/linearalgebra/gmx_lapack/slasd7.c
src/gromacs/linearalgebra/gmx_lapack/slasq1.c
src/gromacs/linearalgebra/gmx_lapack/slasq2.c
src/gromacs/linearalgebra/gmx_lapack/slasq3.c
src/gromacs/linearalgebra/gmx_lapack/slasq4.c
src/gromacs/linearalgebra/gmx_lapack/slasq6.c
src/gromacs/linearalgebra/gmx_lapack/slasr.c
src/gromacs/linearalgebra/gmx_lapack/slassq.c
src/gromacs/linearalgebra/gmx_lapack/slasv2.c
src/gromacs/linearalgebra/gmx_lapack/sorml2.c
src/gromacs/linearalgebra/gmx_lapack/sstebz.c
src/gromacs/linearalgebra/gmx_lapack/sstegr.c
src/gromacs/linearalgebra/gmx_lapack/sstein.c
src/gromacs/linearalgebra/gmx_lapack/ssteqr.c
src/gromacs/linearalgebra/gmx_lapack/ssterf.c
src/gromacs/linearalgebra/gmx_lapack/ssyevr.c
src/gromacs/linearalgebra/gmx_lapack/ssytd2.c
src/gromacs/linearalgebra/gmx_lapack/strtri.c
src/gromacs/mdlib/mvxvf.c

index 845c3fe86995443ac3a5f333d57389cf84e9e887..d566a5081832578621f6c5924a308bb398d39172 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
 #include <config.h>
 #endif
 
-
-#include <sysstuff.h>
-#include <string.h>
 #include <math.h>
+#include <string.h>
+
 #include "typedefs.h"
 #include "smalloc.h"
 #include "xvgr.h"
index 7a67159d25dfc43b6d23ef4f1b8d03a3f29e3653..29a44bb1a94db871c514daf7cd9e8a20a331f377 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
 #ifdef HAVE_CONFIG_H
 #include <config.h>
 #endif
-#include <typedefs.h>
 
+#include <math.h>
+
+#include "typedefs.h"
 #include "smalloc.h"
 #include "macros.h"
-#include <math.h>
 #include "xvgr.h"
 #include "gromacs/commandline/pargs.h"
 #include "string2.h"
 #include "index.h"
 #include "pbc.h"
 #include "gmx_fatal.h"
-#include "gromacs/fileio/futil.h"
 #include "gstat.h"
 #include "pbc.h"
 #include "do_fit.h"
 #include "gmx_ana.h"
-#include "gromacs/fileio/trxio.h"
 
+#include "gromacs/fileio/futil.h"
+#include "gromacs/fileio/trxio.h"
 
 int gmx_helixorient(int argc, char *argv[])
 {
index 7274187626040991b722337dffa6b9295b5208c4..26506521f75a226a10687acc9e964cac7bc1d28d 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -60,8 +60,8 @@
 
 #include "thread_mpi/threads.h"
 
-#if ((defined(WIN32) || defined( _WIN32 ) || defined(WIN64) || defined( _WIN64 )) && !(defined (__CYGWIN__) || defined (__CYGWIN32__)))
-#include "windows.h"
+#ifdef GMX_NATIVE_WINDOWS
+#include <windows.h>
 #endif
 
 #ifdef GMX_GPU
index 21e67fede07569d465bf224d65cbe2ea9ffa2a6f..c7eed3af6793a9839333ea0ef46345a32e5aa69d 100644 (file)
 #include <config.h>
 #endif
 
-#include <sysstuff.h>
 #include <ctype.h>
 #include <errno.h>
 #include <stdarg.h>
 #include <string.h>
-#include "gromacs/fileio/futil.h"
+
 #include "main.h"
 #include "network.h"
 #include "gmx_fatal.h"
@@ -51,8 +50,9 @@
 #include "macros.h"
 #include "string2.h"
 #include "smalloc.h"
-#include "gromacs/fileio/gmxfio.h"
 
+#include "gromacs/fileio/futil.h"
+#include "gromacs/fileio/gmxfio.h"
 #include "gromacs/utility/gmxmpi.h"
 
 #include "gromacs/legacyheaders/thread_mpi/threads.h"
index 58efa528abf751290f947e49cfc8178eb60742a3..ea7dd6e63d1526d76796a29e4f8e70425171ef9a 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2008, The GROMACS development team.
- * Copyright (c) 2012, by the GROMACS development team, led by
+ * Copyright (c) 2012,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -38,7 +38,7 @@
 #include <config.h>
 #endif
 
-#include <gmx_random.h>
+#include "gmx_random.h"
 
 #include <stdio.h>
 #include <stdlib.h>
index 2a27bf746b2fa837ec57ac6276c49c4f3f2e8bcf..f2bb4c4beebf517311eebfce6719604e4f8241fa 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -43,7 +43,7 @@
 #include <limits.h>
 #include "maths.h"
 #ifdef HAVE__FINITE
-#include "float.h"
+#include <float.h>
 #endif
 
 int gmx_nint(real a)
index d383740c1f5215b8eaf3634538b7b293fccdf50d..e742ee21fb561443fb520948d78b93a8b45b4f3f 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -39,8 +39,8 @@
 #include <config.h>
 #endif
 
-#include <sysstuff.h>
 #include <string.h>
+
 #include "typedefs.h"
 #include "main.h"
 #include "mvdata.h"
index 6bad4efb218968d99b6232e13551acd228ec6ad3..06800ba1b2f036b946a5ee5ade16e60b572387d6 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -49,7 +49,7 @@
 #include "smalloc.h"
 #include "main.h"
 #ifdef WITH_DMALLOC
-#include "dmalloc.h"
+#include <dmalloc.h>
 #endif
 
 #ifdef DEBUG
index 6ab168a4224706ff02696e3b39eb35adec2dbe30..6fdfad79c544ceb8cc0113128ec7b619c256fe17 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2009,2010, by the GROMACS development team, led by
+ * Copyright (c) 2009,2010,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
 #include <math.h>
 #include <string.h>
 
-#include <smalloc.h>
-#include <vec.h>
+#include "smalloc.h"
+#include "vec.h"
 
-#include <histogram.h>
+#include "histogram.h"
 
 /*! \internal \brief
  * Stores data for a histogram.
index 5fc6206c6a4fd953cd91fe4497a2acbd900a1eab..8bdcbe7b52656a1c363bb9d9d0f59f880bdde06b 100644 (file)
@@ -19,7 +19,7 @@
 #include <stdlib.h>
 #include <string.h>
 #ifdef WITH_DMALLOC
-#include "dmalloc.h"
+#include <dmalloc.h>
 #endif
 
 
diff --git a/src/gromacs/gmxlib/trajana/displacement.c b/src/gromacs/gmxlib/trajana/displacement.c
deleted file mode 100644 (file)
index b1d02c1..0000000
+++ /dev/null
@@ -1,534 +0,0 @@
-/*
- * This file is part of the GROMACS molecular simulation package.
- *
- * Copyright (c) 2009,2010,2012,2013, by the GROMACS development team, led by
- * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
- * and including many others, as listed in the AUTHORS file in the
- * top-level source directory and at http://www.gromacs.org.
- *
- * GROMACS is free software; you can redistribute it and/or
- * modify it under the terms of the GNU Lesser General Public License
- * as published by the Free Software Foundation; either version 2.1
- * of the License, or (at your option) any later version.
- *
- * GROMACS is distributed in the hope that it will be useful,
- * but WITHOUT ANY WARRANTY; without even the implied warranty of
- * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
- * Lesser General Public License for more details.
- *
- * You should have received a copy of the GNU Lesser General Public
- * License along with GROMACS; if not, see
- * http://www.gnu.org/licenses, or write to the Free Software Foundation,
- * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
- *
- * If you want to redistribute modifications to GROMACS, please
- * consider that scientific software is very special. Version
- * control is crucial - bugs must be traceable. We will be happy to
- * consider code for inclusion in the official distribution, but
- * derived work must not be called official GROMACS. Details are found
- * in the README & COPYING files - if they are missing, get the
- * official version at http://www.gromacs.org.
- *
- * To help us fund GROMACS development, we humbly ask that you cite
- * the research papers on the package. Check out http://www.gromacs.org.
- */
-/*! \page displacements Displacement calculation routines
- *
- * Functions to calculate particle displacements as a function of time are
- * defined in displacement.h.
- * These functions allow one to easily calculate the displacement during a
- * single pass over the trajectory.
- * A new calculation is initialized with gmx_ana_displ_create().
- * For each frame, gmx_ana_displ_start_frame() needs to be called, followed by
- * a series of gmx_ana_displ_store() or a single call to
- * gmx_ana_displ_store_array(), gmx_ana_displ_store_all() or
- * gmx_ana_displ_store_pos().
- * The displacements for the current frame can then be calculated with
- * gmx_ana_displ_vector(), gmx_ana_displ_vectors() and/or
- * gmx_ana_displ_vectors_all().
- * These calculate the displacements from old positions to the ones on the
- * current frame.
- * The input frames should be evenly spaced, otherwise a fatal error is
- * reported. A time interval can be converted to a number of steps for
- * the calculation functions using gmx_ana_displ_time_to_steps().
- * When the structure is no longer required, gmx_ana_displ_free() can be used
- * to free the memory.
- *
- * The functions support calculation for dynamic selections:
- * when storing the positions, it is possible to specify whether a particle
- * is present or not.
- * This data is then accessible in the \p pout array returned by the
- * calculation functions.
- * Note that if you only call gmx_ana_displ_store() for the particles that are
- * present, use gmx_ana_displ_store_array(), or use positions calculated without
- * POS_MASKONLY for gmx_ana_displ_store_pos(), you should ensure that you
- * do not use the displacements for which \p pout is FALSE (the values cannot
- * be calculated based on the provided data, and are undefined).
- */
-/*! \internal \file
- * \brief Implementation of functions in displacement.h.
- */
-#ifdef HAVE_CONFIG_H
-#include <config.h>
-#endif
-
-#include <math.h>
-
-#include <pbc.h>
-#include <smalloc.h>
-#include <vec.h>
-
-#include <displacement.h>
-#include <position.h>
-
-/*! \internal \brief
- * Internal structure used by the displacement calculation routines in
- * displacement.h.
- */
-typedef struct gmx_ana_displpos_t
-{
-    /** Stored position vector. */
-    rvec                     x;
-    /** TRUE if there is something stored. */
-    gmx_bool                 bPres;
-} gmx_ana_displpos_t;
-
-/*! \internal
- * \brief
- * Stores displacement calculation data and parameters.
- *
- * There data can be accessed only through the functions defined in
- * displacement.h.
- */
-struct gmx_ana_displ_t
-{
-    /** Maximum number of particles for which the displacements are calculated. */
-    int                  nmax;
-    /** Maximum time for which the displacements are needed. */
-    real                 tmax;
-
-    /** TRUE if no frames have been read. */
-    gmx_bool                 bFirst;
-    /** Stores the time of the first frame. */
-    real                     t0;
-    /** Stores the time interval between frames. */
-    real                     dt;
-    /** Stores the time of the current frame. */
-    real                     t;
-    /** Stores the index in the store for the current positions. */
-    int                      ci;
-
-    /** Maximum number of positions to store for a particle. */
-    int                  max_store;
-    /** The total number of positions ever stored (can be larger than \p max_store). */
-    int                  nstored;
-    /** Two-dimensional array of stored positions, second index is the particle position. */
-    gmx_ana_displpos_t **p;
-    /** Pointer to the memory allocated for \p p. */
-    gmx_ana_displpos_t  *palloc;
-};
-
-/*!
- * \param[out] data Displacement calculation data structure pointer to
- *   initialize.
- * \param[in]  nmax Number of particles
- *   for which displacements should be calculated.
- * \param[in]  tmax Maximum interval (in same units as in the trajectory)
- *   for which displacements are required.
- * \returns    0 on success.
- *
- * This function only allocates memory for the first frame;
- * gmx_ana_displ_start_frame() allocates a sufficient amount of memory for
- * storing all the required positions once it known the interval between
- * the trajectory frames.
- */
-int
-gmx_ana_displ_create(gmx_ana_displ_t **data, int nmax, real tmax)
-{
-    gmx_ana_displ_t *d;
-
-    snew(d, 1);
-    d->nmax        = nmax;
-    d->tmax        = tmax;
-
-    d->bFirst      = TRUE;
-    d->t0          = 0;
-    d->dt          = 0;
-    d->t           = 0;
-    d->ci          = -1;
-    d->nstored     = 0;
-
-    d->max_store   = -1;
-    snew(d->palloc, nmax);
-    snew(d->p,      1);
-    d->p[0]        = d->palloc;
-
-    *data = d;
-    return 0;
-}
-
-/*!
- * \param[in,out] d   Displacement calculation data.
- * \param[in]     t   Time for the new frame.
- * \returns       0 on success, -1 on failure.
- *
- * This function should be called at the beginning of each frame for which
- * atomic positions should be stored.
- * It is required that the times for which this function is called are
- * evenly spaced; otherwise, it reports a fatal error.
- */
-int
-gmx_ana_displ_start_frame(gmx_ana_displ_t *d, real t)
-{
-    int   i;
-
-    /* Initialize times */
-    if (d->bFirst)
-    {
-        d->t0 = t;
-    }
-    else if (d->dt <= 0)
-    {
-        d->dt = t - d->t0;
-    }
-    else
-    {
-        if (!gmx_within_tol(t - d->t, d->dt, GMX_REAL_EPS))
-        {
-            gmx_input("Trajectory not evenly spaced");
-            return -1;
-        }
-    }
-    d->t = t;
-
-    /* Allocate memory for all the positions once it is possible */
-    if (d->max_store == -1 && !d->bFirst)
-    {
-        d->max_store = (int)(d->tmax/d->dt + 1);
-        srenew(d->palloc, d->nmax * d->max_store);
-        sfree(d->p);
-        snew(d->p, d->max_store);
-        for (i = 0; i < d->max_store; ++i)
-        {
-            d->p[i] = &d->palloc[d->nmax*i];
-        }
-    }
-
-    /* Increment the index where current positions are stored */
-    d->ci++;
-    if (d->ci >= d->max_store)
-    {
-        d->ci = 0;
-    }
-
-    for (i = 0; i < d->nmax; ++i)
-    {
-        d->p[d->ci][i].bPres = FALSE;
-    }
-    d->nstored++;
-    d->bFirst = FALSE;
-    return 0;
-}
-
-/*!
- * \param[in]     d     Displacement calculation data.
- * \param[in]     time  Time to convert to steps.
- * \param[out]    steps The number of steps between the frames separated by
- *   \p time, 0 if the number of steps cannot be determined.
- * \returns       0 on success (also if \p *steps is 0), -1 on error.
- *
- * \p *steps is set to zero if gmx_ana_displ_start_frame() has not yet been
- * called twice.
- * -1 is returned if \p time is not an integer multiple of the interval
- * between frames.
- */
-int
-gmx_ana_displ_time_to_steps(gmx_ana_displ_t *d, real time, int *steps)
-{
-    if (d->dt <= 0)
-    {
-        *steps = 0;
-        return 0;
-    }
-    if (!gmx_within_tol(fmod(time, d->dt), 0, GMX_REAL_EPS))
-    {
-        gmx_input("Interval not multiple of trajectory time step");
-        return -1;
-    }
-    *steps = (int)(time / d->dt + 0.5);
-    return 0;
-}
-
-/*!
- * \param[in,out] d     Displacement calculation data.
- * \param[in]     id    Particle ID.
- * \param[in]     x     Particle position.
- * \param[in]     bPres TRUE if the particle should be marked as present.
- * \returns       0 on success.
- */
-int
-gmx_ana_displ_store(gmx_ana_displ_t *d, atom_id id, rvec x, gmx_bool bPres)
-{
-    copy_rvec(x, d->p[d->ci][id].x);
-    d->p[d->ci][id].bPres = bPres;
-    return 0;
-}
-
-/*!
- * \param[in,out] d     Displacement calculation data.
- * \param[in]     n     Number of elements in the \p id and \p x arrays.
- * \param[in]     id    Particle IDs.
- * \param[in]     x     Particle positions.
- * \returns       0 on success.
- *
- * The positions of the given \p n particles are stored, and all of them
- * are marked as present.
- */
-int
-gmx_ana_displ_store_array(gmx_ana_displ_t *d, int n, atom_id id[], rvec x[])
-{
-    int i;
-
-    for (i = 0; i < n; ++i)
-    {
-        gmx_ana_displ_store(d, id[i], x[i], TRUE);
-    }
-    return 0;
-}
-
-/*!
- * \param[in,out] d     Displacement calculation data.
- * \param[in]     id    Particle IDs.
- * \param[in]     x     Particle positions.
- * \returns       0 on success.
- *
- * Both the \p id and \p x arrays should have
- * \p nmax items, where \p nmax was provided for gmx_ana_displ_create(), and
- * the \p id[i] should be either \p i or -1.
- * If \p id[i]==-1, then that particle is marked as not present,
- * but the position is still stored.
- */
-int
-gmx_ana_displ_store_all(gmx_ana_displ_t *d, atom_id id[], rvec x[])
-{
-    int i;
-
-    for (i = 0; i < d->nmax; ++i)
-    {
-        gmx_ana_displ_store(d, i, x[i], id[i] >= 0);
-    }
-    return 0;
-}
-
-/*!
- * \param[in,out] d     Displacement calculation data.
- * \param[in]     p     Particle positions.
- * \returns       0 on success.
- *
- * \p p should have at most \p nmax positions, where \p nmax was provided for
- * gmx_ana_displ_create().
- * If \p has exactly \p nmax positions, gmx_ana_displ_store_all() is called,
- * otherwise gmx_ana_displ_store_array() is used.
- */
-int
-gmx_ana_displ_store_pos(gmx_ana_displ_t *d, gmx_ana_pos_t *p)
-{
-    if (p->nr == d->nmax)
-    {
-        gmx_ana_displ_store_all(d, p->m.refid, p->x);
-    }
-    else
-    {
-        gmx_ana_displ_store_array(d, p->nr, p->m.refid, p->x);
-    }
-    return 0;
-}
-
-/*! \brief
- * Finds the index in the displacement position storage array.
- *
- * \param[in] d    Displacement calculation data.
- * \param[in] step Calculate the index of positions \p steps back.
- * \returns   Index into the \ref gmx_ana_displ_t::p "d->p" array
- *   that contains the positions \p steps back, -1 on error.
- *
- * If \p step is too large, -1 is returned.
- */
-static int
-find_store_index(gmx_ana_displ_t *d, int step)
-{
-    int si;
-
-    si = d->ci - step;
-    if (si < 0)
-    {
-        si += d->max_store;
-    }
-    if (si < 0)
-    {
-        gmx_incons("Displacement requested for an interval too long");
-        return -1;
-    }
-
-    return si;
-}
-
-/*!
- * \param[in]     d     Displacement calculation data.
- * \param[in]     step  Displacement is calculated from the location
- *   \p step steps back.
- * \param[in]     pbc   Periodic boundary structure
- *   (if NULL, PBC are not used in distance calculation).
- * \param[in]     id    Particle ID for which the displacement is calculated.
- * \param[in]     x     Current particle position.
- * \param[out]    xout  Displacement of the particle.
- * \param[out]    pout  TRUE if the old particle position was marked present.
- *   If \p *pout is FALSE and the old particle position was not stored,
- *   the value of \p xout is undefined.
- *   Can be NULL, in which case the value is not stored.
- * \return        0 on success, -1 if less than \p step frames have been
- *   stored or \p step <= 0, or EINVAL if \p step is too large.
- */
-int
-gmx_ana_displ_vector(gmx_ana_displ_t *d, int step, t_pbc *pbc,
-                     atom_id id, rvec x, rvec xout, gmx_bool *pout)
-{
-    int si;
-
-    if (step >= d->nstored || step <= 0)
-    {
-        return -1;
-    }
-    si = find_store_index(d, step);
-    if (si == -1)
-    {
-        return EINVAL;
-    }
-    if (pout)
-    {
-        *pout = d->p[si][id].bPres;
-    }
-    if (pbc)
-    {
-        pbc_dx(pbc, x, d->p[si][id].x, xout);
-    }
-    else
-    {
-        rvec_sub(x, d->p[si][id].x, xout);
-    }
-    return 0;
-}
-
-/*!
- * \param[in]     d     Displacement calculation data.
- * \param[in]     step  Displacement is calculated from the location
- *   \p step steps back.
- * \param[in]     pbc   Periodic boundary structure
- *   (if NULL, PBC are not used in distance calculation).
- * \param[in]     n     Number of particles for which to calculate.
- * \param[in]     id    Particle IDs for which the displacement is calculated.
- * \param[in]     x     Current particle positions.
- * \param[out]    xout  Displacement of the particles.
- * \param[out]    pout  TRUE if the old particle position was marked present.
- *   If \p pout[i] is FALSE and the old particle position was not stored,
- *   the value of \p xout[i] is undefined.
- *   Can be NULL, in which case the value is not stored.
- * \return        0 on success, -1 if less than \p step frames have been
- *   stored or \p step <= 0, or EINVAL if \p step is too large.
- */
-int
-gmx_ana_displ_vectors(gmx_ana_displ_t *d, int step, t_pbc *pbc,
-                      int n, atom_id id[], rvec x[], rvec xout[], gmx_bool *pout)
-{
-    int si, i;
-
-    if (step >= d->nstored || step <= 0)
-    {
-        return -1;
-    }
-    si = find_store_index(d, step);
-    if (si == -1)
-    {
-        return EINVAL;
-    }
-    for (i = 0; i < n; ++i)
-    {
-        if (pout)
-        {
-            pout[i] =  d->p[si][id[i]].bPres;
-        }
-        if (pbc)
-        {
-            pbc_dx(pbc, x[i], d->p[si][id[i]].x, xout[i]);
-        }
-        else
-        {
-            rvec_sub(x[i], d->p[si][id[i]].x, xout[i]);
-        }
-    }
-    return 0;
-}
-
-/*!
- * \param[in]     d     Displacement calculation data.
- * \param[in]     step  Displacement is calculated from the location
- *   \p step steps back.
- * \param[in]     pbc   Periodic boundary structure
- *   (if NULL, PBC are not used in distance calculation).
- * \param[in]     x     Current particle positions.
- * \param[out]    xout  Displacement of the particles.
- * \param[out]    pout  TRUE if the old particle position was marked present.
- *   If \p pout[i] is FALSE and the old particle position was not stored,
- *   the value of \p xout[i] is undefined.
- *   Can be NULL, in which case the value is not stored.
- * \return        0 on success, -1 if less than \p step frames have been
- *   stored or \p step <= 0, or EINVAL if \p step is too large.
- *
- * The \p x array should have \p nmax items, where \p nmax is the one provided
- * to init_displ_calc().
- */
-int
-gmx_ana_displ_vectors_all(gmx_ana_displ_t *d, int step, t_pbc *pbc,
-                          rvec x[], rvec xout[], gmx_bool *pout)
-{
-    int si, i;
-
-    if (step >= d->nstored || step <= 0)
-    {
-        return -1;
-    }
-    si = find_store_index(d, step);
-    if (si == -1)
-    {
-        return EINVAL;
-    }
-    for (i = 0; i < d->nmax; ++i)
-    {
-        if (pout)
-        {
-            pout[i] =  d->p[si][i].bPres;
-        }
-        if (pbc)
-        {
-            pbc_dx(pbc, x[i], d->p[si][i].x, xout[i]);
-        }
-        else
-        {
-            rvec_sub(x[i], d->p[si][i].x, xout[i]);
-        }
-    }
-    return 0;
-}
-
-/*!
- * \param[in,out] d  Displacement calculation data.
- *
- * After the call, the pointer \p d is invalid.
- */
-void
-gmx_ana_displ_free(gmx_ana_displ_t *d)
-{
-    sfree(d->p);
-    sfree(d->palloc);
-    sfree(d);
-}
index 1ff1b5b00e5181411a0cae93d69566c4eefa1da7..3a1b6602f11ed9f69f4a8a9ea5f5ae7bb7ed0a76 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -38,8 +38,8 @@
 #include <config.h>
 #endif
 
-#include <sysstuff.h>
 #include <string.h>
+
 #include "smalloc.h"
 #include "copyrite.h"
 #include "string2.h"
diff --git a/src/gromacs/legacyheaders/displacement.h b/src/gromacs/legacyheaders/displacement.h
deleted file mode 100644 (file)
index 8a382b6..0000000
+++ /dev/null
@@ -1,102 +0,0 @@
-/*
- * This file is part of the GROMACS molecular simulation package.
- *
- * Copyright (c) 2009,2010, by the GROMACS development team, led by
- * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
- * and including many others, as listed in the AUTHORS file in the
- * top-level source directory and at http://www.gromacs.org.
- *
- * GROMACS is free software; you can redistribute it and/or
- * modify it under the terms of the GNU Lesser General Public License
- * as published by the Free Software Foundation; either version 2.1
- * of the License, or (at your option) any later version.
- *
- * GROMACS is distributed in the hope that it will be useful,
- * but WITHOUT ANY WARRANTY; without even the implied warranty of
- * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
- * Lesser General Public License for more details.
- *
- * You should have received a copy of the GNU Lesser General Public
- * License along with GROMACS; if not, see
- * http://www.gnu.org/licenses, or write to the Free Software Foundation,
- * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
- *
- * If you want to redistribute modifications to GROMACS, please
- * consider that scientific software is very special. Version
- * control is crucial - bugs must be traceable. We will be happy to
- * consider code for inclusion in the official distribution, but
- * derived work must not be called official GROMACS. Details are found
- * in the README & COPYING files - if they are missing, get the
- * official version at http://www.gromacs.org.
- *
- * To help us fund GROMACS development, we humbly ask that you cite
- * the research papers on the package. Check out http://www.gromacs.org.
- */
-/*! \file
- * \brief API for on-line calculation of displacements.
- *
- * The API is documented in more detail on a separate page:
- * \ref displacements
- *
- * The functions within this file can be used and developed independently of
- * the other parts of the library.
- * Other parts of the library do not reference these functions.
- */
-#ifndef DISPLACEMENT_H
-#define DISPLACEMENT_H
-
-#include "typedefs.h"
-
-#ifdef __cplusplus
-extern "C"
-{
-#endif
-
-/** Data structure for displacement calculation. */
-typedef struct gmx_ana_displ_t gmx_ana_displ_t;
-
-struct gmx_ana_pos_t;
-
-/** Allocates memory for displacement calculation. */
-int
-gmx_ana_displ_create(gmx_ana_displ_t **d, int nmax, real tmax);
-/** Initializes displacement calculation for a frame. */
-int
-gmx_ana_displ_start_frame(gmx_ana_displ_t *d, real t);
-/** Returns the number of steps corresponding to a given time interval. */
-int
-gmx_ana_displ_time_to_steps(gmx_ana_displ_t *d, real time, int *nsteps);
-/** Stores the position of a particle for displacement calculation. */
-int
-gmx_ana_displ_store(gmx_ana_displ_t *d, atom_id id, rvec x, gmx_bool bPres);
-/** Convenience function for storing an array of particle positions for displacement calculation. */
-int
-gmx_ana_displ_store_array(gmx_ana_displ_t *d, int n, atom_id id[], rvec x[]);
-/** Stores an array of particle positions for displacement calculation, including unselected particles. */
-int
-gmx_ana_displ_store_all(gmx_ana_displ_t *d, atom_id id[], rvec x[]);
-/** Convenience function for storing a set of positions from \c gmx_ana_pos_t. */
-int
-gmx_ana_displ_store_pos(gmx_ana_displ_t *d, struct gmx_ana_pos_t *p);
-/** Calculates the displacement vector for a particle. */
-int
-gmx_ana_displ_vector(gmx_ana_displ_t *d, int step, t_pbc *pbc,
-                     atom_id id, rvec x, rvec xout, gmx_bool *pout);
-/** Calculates the displacement vectors for a list of particles. */
-int
-gmx_ana_displ_vectors(gmx_ana_displ_t *d, int step, t_pbc *pbc,
-                      int n, atom_id id[], rvec x[],
-                      rvec xout[], gmx_bool *pout);
-/** Calculates the displacement vectors for all particles, including unselected. */
-int
-gmx_ana_displ_vectors_all(gmx_ana_displ_t *d, int step, t_pbc *pbc,
-                          rvec x[], rvec xout[], gmx_bool *pout);
-/** Frees the memory allocated for displacement calculation. */
-void
-gmx_ana_displ_free(gmx_ana_displ_t *d);
-
-#ifdef __cplusplus
-}
-#endif
-
-#endif
index ee0a4dc56077bb688a1c6c653e3f92d99e715906..5aa2340e0e4fa3c9ae627f87385d08f0ab497317 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 
index e7711fe7274ee74354473f796b50190b182fd96e..782d3dcff0d051ea532c297e901ede75f59441c5 100644 (file)
@@ -1,7 +1,7 @@
 #include <math.h>
 #include <ctype.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 
index 8c75ce202559c4100961e58c84b0055533bf5a75..6b3b3a4d60793ad6b25c61edce353cae7cc54090 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 
index 884d681f4c7d5dd52725b6d4572363eef476ea0b..45d93784be19f8f9e51655c69ddd8fdcdbd48357 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 double
index 1cb187d454040ca9f8f62f089c44c7d2a1f5c072..0fa6d0fc8bb3def233147440cc077d64b7da2167 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index c6c5595f50e086cbd44dee5b43b45d7ecac4954f..4c5290fcb659bdd462f60e95e1bd57d020a0cb59 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 
index 522183ea6a09d300fea0e3b037c467b6f81dc9eb..7fe83d92791d1b2f3769a94d7d61e28649106ae4 100644 (file)
@@ -2,7 +2,7 @@
 #include <ctype.h>
 
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index 33096703501af63da0be55e3353dd33e4ecf0d81..71c43bc74471ac141564eefeae355ca6acb948cd 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 
index 9b20bd2ca04785e9404bb74854fb8d14a790d030..959015f80a4a0a330223c42db83ed8858c7337aa 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void 
index 2c2f2faf929adde725d3f8c356ee7cbecd21442f..45d04987b7514b29d2a7204eb917bfca37d32231 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index 46839cfb3dba637ea140f297bf16c93be4e4da51..7b4bb05a6217dc7e5d36fada83e47651b7f444e4 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index e1c2a760698da7bcedb5107d9d92192ecbba7b5d..b9a3b5a5884c36e549d8959927cd3f35f0c463ed 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index 8be02f3515f6f4f5cb4d00c4443cdfc61424eec0..ca7e55806928a69e4fdb3aca83e42bdacb0d7e3f 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index a1dcec478a2e5244023bfd2fbccf49094a8cde85..eaa5cd592133783eed71eebf2d0ed1e5780ef933 100644 (file)
@@ -1,7 +1,7 @@
 #include <math.h>
 
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 float
index 09bedd9633d530c5294186fc9de275e6e3967775..8f245dd17749b273f81dd94f71a177b2e848d9fd 100644 (file)
@@ -1,7 +1,7 @@
 #include <math.h>
 #include <ctype.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index 24fa37ded2b9b77c57193809f26bcd9f2c46559a..2a9080512dba3d1d55f70180697b7ce70db92249 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index 7220272ce9629bcc1a2db6900db0cb65a5cfd797..1dfae8fcfbb5f419d161256f5229824b8e7b5ae8 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index bffd6d9d3c5548a570f467842d830dea03ddb8bb..39c9f5b43ceae5e9e9190d6eedfaf5ee8b08f250 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void 
index 4646fbf358eebe0886b6a91051f67cf8b3e898be..485df5a2854c2ecb9b73f8866d8ab660eeabbef8 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void 
index 9de5716d4995f9ff8ab4641fcaf308072a8a6f81..1b1d57585a6ada4536368541668987bba45f053f 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_blas.h"
 
 void
index 63c918617a00bb2ee244468c74c18e565d7d2445..d28eccf3afb125d525bece22150cea4d9fe474c8 100644 (file)
@@ -4,7 +4,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dbdsdc,DBDSDC)(const char *uplo, 
index 0c959d3acc85b607f04d1c3faa751ebce48a6e87..3d1cc191af16820f0aa58f31755d7347ad930015 100644 (file)
@@ -4,7 +4,7 @@
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(dbdsqr,DBDSQR)(const char *uplo,
index 385e751c8b94ca630e3e2a9139fac18d7069068c..af54358689e6cb5b154076a0ab27a0ea3870d510 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 0f18d00303e4fa41a9f1e3cd70ebf182d39aa01a..2a0faca7f2f2125e5ea72adec142e57660eb6947 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 66d53595d9fe9ae55b9ec81572dd752735a95a8d..d29b6eee629f98359dc67ffda67c5aa57733eba0 100644 (file)
@@ -2,7 +2,7 @@
 
 #include "../gmx_lapack.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dlaed6,DLAED6)(int *kniter, 
index c112cce3cefb59082b6751d3789c2f157b702f03..66bda5f6d08801358800c48952785fdae61c7b77 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 
index cf34904efde9305f7dfe57a519fd24fc64a5eda2..b8635f549f388efefc18f2aa94cee5ec9419d66d 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index 0f3b470c58bb29f2dc00d630f0059aca2cab7d57..bc342af697ae32f882e82fce933dc3c81a2504a5 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index ca41586641727204cd52fa0d0aff6a00273e3a95..bb03ffed69ba5b255bb33cd162c7db327ac415e5 100644 (file)
@@ -1,7 +1,7 @@
 #include <math.h>
 #include "../gmx_lapack.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 double
 F77_FUNC(dlapy2,DLAPY2)(double * x, double * y)
index a6a369b9a4e57cad3b2fa54d950fbb74f43e6bfe..940c62bb19993def2a62f0004dc6c90df02c2e4f 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index f1072c6470cdaf9cffb26fabe9aaee524c1871f8..7a158cd8fcb967d01da05645b90914e864176722 100644 (file)
@@ -4,7 +4,7 @@
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dlarf,DLARF)(const char *side,
index b587a0986133d0e0764404b34eed82c840209c40..030755479e4086d37993e0b1a4b56e9256262f91 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index aadc6420299fe6b057ad67de29847616790ba5dd..950074cacda6fde6d5178d668c68dd8cdbb00f83 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index bf630231b7ef4a3100e695c002eac06b74932938..3c4c8b46d84ddd6a5147c1bc9570aff4ef5d346b 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index f98b0ff349a2f62cf9ad310821f58e399ea64174..e8998f83ab354f312e701fde34eeb68a07fef19e 100644 (file)
@@ -1,7 +1,7 @@
 #include <math.h>
 #include <ctype.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 15f4990145b38783280bb5e004d82e03f135d481..cc4d67006dd3aa7ad742735bb21a0955829ad287 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 9faad556d0e464e90ffd0dcda2495582790d3626..a9c21bd53dd80ef392ac9c9a4d0692727f794e39 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index a85ffb4a2cad18232da967f5d5763bd8091b33ff..0e51c5092bc5ba21441597afc03066d207577e7f 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dlartg,DLARTG)(double *f,
index aa5cc85aa8a8474133d7e0d1dcdf30875d720633..ba6fe95b269093b289042b9d802f054df8fd49e7 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 
index d5de6a02dc93a7d4ce178806ee561282661dfc62..0cd9aa83ac43a16001aca71e4a34f7c601f3582c 100644 (file)
@@ -1,6 +1,6 @@
 #include <ctype.h>
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index 76c9f9fe80ade8cb3421652a5971bf77a5971c9b..1c87fd9131d87c50392630a3c94fc3f641a45884 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(dlasd2,DLASD2)(int *nl, 
index 7d2ed185a840151e1bd5d3adf7b77d410eae3a44..778a64e8c187c5839719ace183bd5571df089664 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(dlasd4,DLASD4)(int *n, 
index 336b9deed4c85a07986c7a02f2774791d42c372b..23657fa4e2cc8518787a5472159945997feb5433 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 471e2cc505deccd3af42a15394d1c14449d7790b..9a11b8dcee6d795b956e142c52bc34f43750a5a5 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dlasq1,DLASQ1)(int *n,
index a778a9ba1aa61659d75f6001e77e5642498c4759..4da15558bbe99165b8888cd1554bc745d828dc68 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #ifdef _MSC_VER
 #pragma warning(disable: 4723) /*division by zero - is used on purpose here*/
index 6dc478bf8425287525d9b712a69d582763689b09..d9ba8eec5838ca9e50aebbff36f7b8b5b068c637 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index 798f46bb4f567a91be3181762b42162d21d76f78..1b24e4a921997ddfe48783c63cb74fb99b4560d8 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 
index 1ae5342b5e2807c934f52742cb4a2b4c29414650..3c5cca66bca4db1b2db9e2f1912e6b6aedcabfa4 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(dlasq6,DLASQ6)(int *i0, 
index 31f238141444fadc013bfdac9f75ae15018a668b..c265865e4dd108cc64c3d2bafb43e1cb159abd20 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_lapack.h"
 
 void 
index 318dcc3d990dd97f9924318da54de1802ee8eaba..300d46c24cd656c4ec86de49d2777cc0b2c22c04 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_lapack.h"
 
 void
index a5e8c2090144334f18d83e2af1fa2ce45c71b4ac..7f74ebdde0ab49a12b8c8f5be5817c5b31f02ca4 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(dlasv2,DLASV2)(double *f, 
index 684dc24bbb85b8d6da547e90898d9f6f40de9ec9..c02cf834107e306490c0289194bc4cf4a1f5dbb3 100644 (file)
@@ -1,6 +1,6 @@
 #include <ctype.h>
 #include "../gmx_lapack.h"
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dorml2,DORML2)(const char *side,
index cfdaccd17b5d3025a2e8a8de7deb3d8d6bceb948..0cfd2fa1e36a50f744ad9d00f152bb19ac1ebd66 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dstebz,DSTEBZ)(const char *range, 
index 9a6f449bddc8c12626513b36456c59a5bc06c654..1e2128f0750d1d34c241dfdcb223242638b8e0ea 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dstegr,DSTEGR)(const char *jobz, 
index 24d145be21e8f7a0abd114cde3cd533c6b41caa5..c46d8ca30126e6d28c1c7b675bb5f6e8a232f0bd 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dstein,DSTEIN)(int *n, 
index 20ed0b7c176231506b6c39807ef003a220c2df20..b7e10363dcffc4f9259233922206cf346046b6db 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 4508b36ae4a2eea3d4fd82f8d807b9ecc4272ead..71f2e3dd48086989766f25b53c6b3db141fe8ce6 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dsterf,DSTERF)(int *n, 
index add48e7e2750c08abdbe699c3906262f316b5ada..4397832c70722d66578fef4131e5318f455713ba 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 3a527347f779834dac8deca3b929b3f6bb28ff8c..2e36d03af7a4d294193eb5e1199e448e87da7056 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index c636dfe3c6cf433a3fd42b3f5ab81dbd29558f5b..5caebbccb64444d3f79d26b67b78ac49f874f81c 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(dtrtri,DTRTRI)(const char *uplo,
index 44cb172239937c78907bef3142599ead8d0bbdec..43c00d42dd6840310bae71b95f4fdb742d7372df 100644 (file)
@@ -4,7 +4,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(sbdsdc,SBDSDC)(const char *uplo, 
index d87a9f74d0b0472c8cf397c5fcc55d683b4e837a..702194077006c55bec2bf8434b4a6e1cafe15586 100644 (file)
@@ -4,7 +4,7 @@
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(sbdsqr,SBDSQR)(const char *uplo,
index 13bc672abc0c6669207ea47547b4457f3df7b792..caad379763ebed1ef740c109bc94ded1b5e1c3e7 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 
 #include "../gmx_blas.h"
index 9b7582e4005475a95c3c4c26eeac4a9d90085362..fc38a8108756300853b5348f17a94c4ddc7ccdd3 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 6f972a586dc60f327f1f325f4255458d74fd6f5d..20cc211ae9e80d243e5962f9ffb9cdf2e9db36fb 100644 (file)
@@ -2,7 +2,7 @@
 
 #include "../gmx_lapack.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(slaed6,SLAED6)(int *kniter, 
index 8761e98c3a6f8bcd88ce2121723c8731ad33ce2d..c47ba0a13f9420a01a9c95ab8909576b9deb2575 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 
index 148249a4784efb34115c5eda37dcc267601d687a..27d096ffa54238cd58cedcc391f9068220fd856e 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index 36a8349f3b70388f2fc9b8d874cb75ce49d62e7a..364234ddc94fbf82dffd5a2e22c92c1ef90ed196 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index 24ead749810df11fe3b308fc517cfcef980961e2..e5ba0629a59335e211f7daaf0b4f0a916f7750fa 100644 (file)
@@ -1,7 +1,7 @@
 #include <math.h>
 #include "../gmx_lapack.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 float
 F77_FUNC(slapy2,SLAPY2)(float * x, float * y)
index 229ea668786d6bc82c7db1825b3555df2f543260..8eb82c8a7580f781a1411f5c4e229e0a354bfcad 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index 70b946ea9f25909da86781486abf77d5ce0bace7..c822defce0c2ac42ee8337fb26c5fd3270c7a6e2 100644 (file)
@@ -4,7 +4,7 @@
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(slarf,SLARF)(const char *side,
index cedca07df6d77ad95c7ebda2937362886ea8c8c3..35f3a25e59a2e397913ec11d57b855e0dfbd9774 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 51b29a71518cacd3aeab49040237137da934d7f8..9a3b6bff4e1acb9a3606d33bb2f0d57ef8441257 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 5d749db56f50c57d8fb9d5deaf27aa9265127058..2b658263af64b0a556c91fbf9c7108eaf55b9c43 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index 7c5e293ebe339b0c21e0c9df5df6778b61937b03..9006e506afb3bfab212527a884729da5e88675df 100644 (file)
@@ -1,7 +1,7 @@
 #include <math.h>
 #include <ctype.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 734891902339451bfa707edef1872784405779ed..9b6565a1e061fee313677ca4ce772d13b796b5bf 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index b8af3c14fbb2dcbcd7bec869c74c4acd66bfb806..efc1124b19630a501da4304af3823e0142211f71 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 4597adc7bfa2849c6620dd08dcc39fe2bb95e8f6..3ea6a462458a9cb2ec00458123ef00395f8202a4 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(slartg,SLARTG)(float *f,
index b4a25a93d7374895f75fdfe470dc2eb65fc1f2d4..bddecad3ea012c96033076b0f8f3f83848f41120 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 
index 84b4cb828f79e1c2be0299db9af1c87eebc121f2..18048e1c23170c4cffd83e6b2dbb80d71b759dc9 100644 (file)
@@ -1,6 +1,6 @@
 #include <ctype.h>
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index 1096aea81ba6198b62596ea13c10223a2051d175..4d683f79043873a3e89dbc3e1a3a85b50019ea5b 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(slasd2,SLASD2)(int *nl, 
index 511a884ca4c876c1f1129525e4fb895450fc5a1b..e87252834ef9294de04f0fed9b83117ab2fac3fe 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(slasd4,SLASD4)(int *n, 
index 3b9bfc853f96619a236771d7d78fca6ab0da2e82..7a70a786640f624c799625f00a55187ed787e470 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 0bb5377b612aafd28c2d0dcd30f61775b022a23b..ac899e8abfa5aaaee37a44fc45b5427bca5b00fb 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(slasq1,SLASQ1)(int *n,
index c5ee55fb0dfee623b3805b2b03135d5e96db9b27..1f0b32bd18f0eee4820e6ed11c4f45b51b77bf63 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #ifdef _MSC_VER
 #pragma warning(disable: 4723) /*division by zero - is used on purpose here*/
index 2b708ab19787a3e2954a31930ddac863a5312135..8a8095687f2b26270bb7a348f9bd1a2b425e1eda 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
index deeab9290e854b80a4e368925f6fae83d211c5e9..cc27e42ccd1a73f32b03f906df9dde9ae8bcb9f5 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_lapack.h"
 
index f740dfd302d71be2cda793cb25f673af297aefc0..38aae9b9da046e13cc8b79697aa66c3be7de913c 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(slasq6,SLASQ6)(int *i0, 
index 0094a6a82554d7f1bd9e237f6b0a45d1c7bdd975..b3c3d8fc842410e652d5f5d0691587bb9d951000 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_lapack.h"
 
 void 
index 2985b11fb3b4a631d6eee62f4a251cfb03ae619c..b38ea32a25416f0873da8201e4b6197fa68c1c57 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_lapack.h"
 
 void
index 4572488f38ee4e14848377f70b48b57584a4d031..969d7851b99c882d1d6371cb76c1d5fbc2ac584b 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void 
 F77_FUNC(slasv2,SLASV2)(float *f, 
index a9b3d965c773b2f86284e7847eac2a41eac1b000..7694ed44bfea1c8c702f61cbc597679d6b597007 100644 (file)
@@ -1,5 +1,5 @@
 #include <ctype.h>
-#include <types/simple.h>
+#include "types/simple.h"
 #include "../gmx_lapack.h"
 
 void
index ae26c4e126263e52ac9b29dd8c9f289efea27dc3..8b9a8da4889009047868c3a7f1c7df52ba30e9e4 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(sstebz,SSTEBZ)(const char *range, 
index dca562dbb05bc9d0137be38b9306699be026a7b2..bb4012fae0889dbb9edd804afe4f3210968b6b4f 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(sstegr,SSTEGR)(const char *jobz, 
index de9036572b8875dc9e6136563106ecade5f45a83..29f4cdaaa4ee36db136ae8b26a5ac98dc73baf45 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(sstein,SSTEIN)(int *n, 
index f378f9d10d39fc01cbdad7148025cba339dd938f..b6834d3912d554f7c210822b33328380c98f17d1 100644 (file)
@@ -1,5 +1,5 @@
 #include <math.h>
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index 13573711d5a3aecee6ca4e06d66227faee0a6be3..8834a31c1f724919e7f0e0cb7bc9850697139a79 100644 (file)
@@ -2,7 +2,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(ssterf,SSTERF)(int *n, 
index d51cc29fe76fad164420b116de6549e8ffcab4e9..0db349e1c8264bc256026ae7633ba5d29f44a695 100644 (file)
@@ -1,6 +1,6 @@
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index f6c6f122fbc0946d6779d8287f9d0c7402755e57..1f035401314d28ed36d8aa524513a1ab9d84822a 100644 (file)
@@ -1,7 +1,7 @@
 #include <ctype.h>
 #include <math.h>
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 #include "../gmx_blas.h"
 #include "../gmx_lapack.h"
index e695e4302a6645365fdd1c9e0a783792c697dc09..5d000c61b3a83df7a137b1a84ef1ea138e4972b5 100644 (file)
@@ -3,7 +3,7 @@
 #include "../gmx_lapack.h"
 #include "lapack_limits.h"
 
-#include <types/simple.h>
+#include "types/simple.h"
 
 void
 F77_FUNC(strtri,STRTRI)(const char *uplo,
index 7ff89e02f66662bef95764b3e7bc1d7b2f1a1af8..494533e0b7d365f627f8c05bd2874039c5e516f1 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -39,8 +39,8 @@
 #include <config.h>
 #endif
 
-#include <sysstuff.h>
 #include <string.h>
+
 #include "typedefs.h"
 #include "main.h"
 #include "mvdata.h"