Move read_tps_conf() to confio.h
authorTeemu Murtola <teemu.murtola@gmail.com>
Wed, 22 Jul 2015 04:38:45 +0000 (07:38 +0300)
committerTeemu Murtola <teemu.murtola@gmail.com>
Wed, 22 Jul 2015 13:52:16 +0000 (16:52 +0300)
This function is nearly identical to read_stx_conf(), and they even
share some helper functions, so they are better in the same file.  Now
tpxio.h is all about reading/writing tpr files, and code to handle
multiple formats is elsewhere.

Change-Id: I348a5bae5fe8aae2ad68ec29fe54068fccd97501

41 files changed:
src/gromacs/fileio/confio.cpp
src/gromacs/fileio/confio.h
src/gromacs/fileio/tests/confio.cpp
src/gromacs/fileio/tpxio.cpp
src/gromacs/fileio/tpxio.h
src/gromacs/gmxana/eigio.c
src/gromacs/gmxana/gmx_bundle.c
src/gromacs/gmxana/gmx_chi.c
src/gromacs/gmxana/gmx_cluster.c
src/gromacs/gmxana/gmx_confrms.c
src/gromacs/gmxana/gmx_current.c
src/gromacs/gmxana/gmx_density.c
src/gromacs/gmxana/gmx_densmap.c
src/gromacs/gmxana/gmx_dipoles.cpp
src/gromacs/gmxana/gmx_do_dssp.c
src/gromacs/gmxana/gmx_filter.c
src/gromacs/gmxana/gmx_genion.c
src/gromacs/gmxana/gmx_gyrate.c
src/gromacs/gmxana/gmx_hydorder.c
src/gromacs/gmxana/gmx_make_edi.c
src/gromacs/gmxana/gmx_mdmat.c
src/gromacs/gmxana/gmx_mindist.c
src/gromacs/gmxana/gmx_msd.c
src/gromacs/gmxana/gmx_nmens.c
src/gromacs/gmxana/gmx_nmtraj.c
src/gromacs/gmxana/gmx_order.c
src/gromacs/gmxana/gmx_principal.c
src/gromacs/gmxana/gmx_rms.c
src/gromacs/gmxana/gmx_rmsdist.c
src/gromacs/gmxana/gmx_rmsf.c
src/gromacs/gmxana/gmx_rotmat.c
src/gromacs/gmxana/gmx_sans.c
src/gromacs/gmxana/gmx_sorient.c
src/gromacs/gmxana/gmx_spatial.c
src/gromacs/gmxana/gmx_traj.c
src/gromacs/gmxana/gmx_trjcat.c
src/gromacs/gmxana/gmx_trjorder.c
src/gromacs/gmxana/gmx_vanhove.c
src/gromacs/gmxana/sfactor.c
src/gromacs/selection/tests/toputils.cpp
src/gromacs/trajectoryanalysis/runnercommon.cpp

index 6a022edff834039381419265552dcc40545af954..a7d9fdaa5d483d4eaf70282fc4927d6c4cec8096 100644 (file)
@@ -58,6 +58,7 @@
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/pbcutil/pbc.h"
+#include "gromacs/topology/atomprop.h"
 #include "gromacs/topology/mtop_util.h"
 #include "gromacs/topology/symtab.h"
 #include "gromacs/topology/topology.h"
@@ -1634,6 +1635,50 @@ void get_stx_coordnum(const char *infile, int *natoms)
     }
 }
 
+static void tpx_make_chain_identifiers(t_atoms *atoms, t_block *mols)
+{
+    int  m, a, a0, a1, r;
+    char c, chainid;
+    int  chainnum;
+
+    /* We always assign a new chain number, but save the chain id characters
+     * for larger molecules.
+     */
+#define CHAIN_MIN_ATOMS 15
+
+    chainnum = 0;
+    chainid  = 'A';
+    for (m = 0; m < mols->nr; m++)
+    {
+        a0 = mols->index[m];
+        a1 = mols->index[m+1];
+        if ((a1-a0 >= CHAIN_MIN_ATOMS) && (chainid <= 'Z'))
+        {
+            c = chainid;
+            chainid++;
+        }
+        else
+        {
+            c = ' ';
+        }
+        for (a = a0; a < a1; a++)
+        {
+            atoms->resinfo[atoms->atom[a].resind].chainnum = chainnum;
+            atoms->resinfo[atoms->atom[a].resind].chainid  = c;
+        }
+        chainnum++;
+    }
+
+    /* Blank out the chain id if there was only one chain */
+    if (chainid == 'B')
+    {
+        for (r = 0; r < atoms->nres; r++)
+        {
+            atoms->resinfo[r].chainid = ' ';
+        }
+    }
+}
+
 void read_stx_conf(const char *infile, char *title, t_atoms *atoms,
                    rvec x[], rvec *v, int *ePBC, matrix box)
 {
@@ -1715,3 +1760,103 @@ void read_stx_conf(const char *infile, char *title, t_atoms *atoms,
             gmx_incons("Not supported in read_stx_conf");
     }
 }
+
+static void done_gmx_groups_t(gmx_groups_t *g)
+{
+    int i;
+
+    for (i = 0; (i < egcNR); i++)
+    {
+        if (NULL != g->grps[i].nm_ind)
+        {
+            sfree(g->grps[i].nm_ind);
+            g->grps[i].nm_ind = NULL;
+        }
+        if (NULL != g->grpnr[i])
+        {
+            sfree(g->grpnr[i]);
+            g->grpnr[i] = NULL;
+        }
+    }
+    /* The contents of this array is in symtab, don't free it here */
+    sfree(g->grpname);
+}
+
+gmx_bool read_tps_conf(const char *infile, char *title, t_topology *top, int *ePBC,
+                       rvec **x, rvec **v, matrix box, gmx_bool bMass)
+{
+    t_tpxheader      header;
+    int              natoms, i, version, generation;
+    gmx_bool         bTop, bXNULL = FALSE;
+    gmx_mtop_t      *mtop;
+    gmx_atomprop_t   aps;
+
+    bTop  = fn2bTPX(infile);
+    *ePBC = -1;
+    if (bTop)
+    {
+        read_tpxheader(infile, &header, TRUE, &version, &generation);
+        if (x)
+        {
+            snew(*x, header.natoms);
+        }
+        if (v)
+        {
+            snew(*v, header.natoms);
+        }
+        snew(mtop, 1);
+        *ePBC = read_tpx(infile, NULL, box, &natoms,
+                         (x == NULL) ? NULL : *x, (v == NULL) ? NULL : *v, NULL, mtop);
+        *top = gmx_mtop_t_to_t_topology(mtop);
+        /* In this case we need to throw away the group data too */
+        done_gmx_groups_t(&mtop->groups);
+        sfree(mtop);
+        std::strcpy(title, *top->name);
+        tpx_make_chain_identifiers(&top->atoms, &top->mols);
+    }
+    else
+    {
+        get_stx_coordnum(infile, &natoms);
+        init_t_atoms(&top->atoms, natoms, (fn2ftp(infile) == efPDB));
+        if (x == NULL)
+        {
+            snew(x, 1);
+            bXNULL = TRUE;
+        }
+        snew(*x, natoms);
+        if (v)
+        {
+            snew(*v, natoms);
+        }
+        read_stx_conf(infile, title, &top->atoms, *x, (v == NULL) ? NULL : *v, ePBC, box);
+        if (bXNULL)
+        {
+            sfree(*x);
+            sfree(x);
+        }
+        if (bMass)
+        {
+            aps = gmx_atomprop_init();
+            for (i = 0; (i < natoms); i++)
+            {
+                if (!gmx_atomprop_query(aps, epropMass,
+                                        *top->atoms.resinfo[top->atoms.atom[i].resind].name,
+                                        *top->atoms.atomname[i],
+                                        &(top->atoms.atom[i].m)))
+                {
+                    if (debug)
+                    {
+                        fprintf(debug, "Can not find mass for atom %s %d %s, setting to 1\n",
+                                *top->atoms.resinfo[top->atoms.atom[i].resind].name,
+                                top->atoms.resinfo[top->atoms.atom[i].resind].nr,
+                                *top->atoms.atomname[i]);
+                    }
+                }
+            }
+            gmx_atomprop_destroy(aps);
+        }
+        top->idef.ntypes = -1;
+    }
+
+    return bTop;
+}
index 2b149c23a82b59884c77e6b218554834b8e03e24..f27b1b648b45f696eb1a583d2764c00b1624e560 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,2014, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015, 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.
@@ -52,6 +52,7 @@ extern "C" {
 
 struct gmx_mtop_t;
 struct t_atoms;
+struct t_topology;
 
 int read_g96_conf(FILE *fp, const char *infile, t_trxframe *fr, char *line);
 /* read a Gromos96 coordinate or trajectory file,                       *
@@ -107,6 +108,15 @@ void read_stx_conf(const char *infile, char *title,
  * If ePBC!=NULL return the type of pbc in *ePBC or -1 if unknown.
  */
 
+gmx_bool read_tps_conf(const char *infile, char *title, struct t_topology *top,
+                       int *ePBC, rvec **x, rvec **v, matrix box, gmx_bool bMass);
+/* Read title, top.atoms, x, v (if not NULL) and box from an STX file,
+ * memory for atoms, x and v will be allocated.
+ * Return TRUE if a complete topology was read.
+ * If infile is a TPX file read the whole top,
+ * else if bMass=TRUE, read the masses into top.atoms from the mass database.
+ */
+
 #ifdef __cplusplus
 }
 #endif
index 00f971c7d02092523bbb2256809ed5e1f17adf14..eb747f4b60afea945e7e51f74f4d1941d763adf7 100644 (file)
@@ -50,7 +50,6 @@
 #include <gtest/gtest.h>
 
 #include "gromacs/fileio/filenm.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/math/vectypes.h"
 #include "gromacs/topology/atoms.h"
index 8aa9492c462ab4f1307f6005bad0647a85416408..623c1d23fc8e816de78a1cdb1824bc65eff68fba 100644 (file)
@@ -45,7 +45,6 @@
 
 #include <algorithm>
 
-#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/filenm.h"
 #include "gromacs/fileio/gmxfio.h"
 #include "gromacs/fileio/gmxfio-xdr.h"
@@ -54,7 +53,6 @@
 #include "gromacs/legacyheaders/names.h"
 #include "gromacs/legacyheaders/txtdump.h"
 #include "gromacs/math/vec.h"
-#include "gromacs/topology/atomprop.h"
 #include "gromacs/topology/block.h"
 #include "gromacs/topology/mtop_util.h"
 #include "gromacs/topology/symtab.h"
@@ -2772,50 +2770,6 @@ static void do_cmap(t_fileio *fio, gmx_cmap_t *cmap_grid, gmx_bool bRead)
 }
 
 
-void tpx_make_chain_identifiers(t_atoms *atoms, t_block *mols)
-{
-    int  m, a, a0, a1, r;
-    char c, chainid;
-    int  chainnum;
-
-    /* We always assign a new chain number, but save the chain id characters
-     * for larger molecules.
-     */
-#define CHAIN_MIN_ATOMS 15
-
-    chainnum = 0;
-    chainid  = 'A';
-    for (m = 0; m < mols->nr; m++)
-    {
-        a0 = mols->index[m];
-        a1 = mols->index[m+1];
-        if ((a1-a0 >= CHAIN_MIN_ATOMS) && (chainid <= 'Z'))
-        {
-            c = chainid;
-            chainid++;
-        }
-        else
-        {
-            c = ' ';
-        }
-        for (a = a0; a < a1; a++)
-        {
-            atoms->resinfo[atoms->atom[a].resind].chainnum = chainnum;
-            atoms->resinfo[atoms->atom[a].resind].chainid  = c;
-        }
-        chainnum++;
-    }
-
-    /* Blank out the chain id if there was only one chain */
-    if (chainid == 'B')
-    {
-        for (r = 0; r < atoms->nres; r++)
-        {
-            atoms->resinfo[r].chainid = ' ';
-        }
-    }
-}
-
 static void do_moltype(t_fileio *fio, gmx_moltype_t *molt, gmx_bool bRead,
                        t_symtab *symtab, int file_version,
                        gmx_groups_t *groups)
@@ -3709,103 +3663,3 @@ gmx_bool fn2bTPX(const char *file)
 {
     return (efTPR == fn2ftp(file));
 }
-
-static void done_gmx_groups_t(gmx_groups_t *g)
-{
-    int i;
-
-    for (i = 0; (i < egcNR); i++)
-    {
-        if (NULL != g->grps[i].nm_ind)
-        {
-            sfree(g->grps[i].nm_ind);
-            g->grps[i].nm_ind = NULL;
-        }
-        if (NULL != g->grpnr[i])
-        {
-            sfree(g->grpnr[i]);
-            g->grpnr[i] = NULL;
-        }
-    }
-    /* The contents of this array is in symtab, don't free it here */
-    sfree(g->grpname);
-}
-
-gmx_bool read_tps_conf(const char *infile, char *title, t_topology *top, int *ePBC,
-                       rvec **x, rvec **v, matrix box, gmx_bool bMass)
-{
-    t_tpxheader      header;
-    int              natoms, i, version, generation;
-    gmx_bool         bTop, bXNULL = FALSE;
-    gmx_mtop_t      *mtop;
-    gmx_atomprop_t   aps;
-
-    bTop  = fn2bTPX(infile);
-    *ePBC = -1;
-    if (bTop)
-    {
-        read_tpxheader(infile, &header, TRUE, &version, &generation);
-        if (x)
-        {
-            snew(*x, header.natoms);
-        }
-        if (v)
-        {
-            snew(*v, header.natoms);
-        }
-        snew(mtop, 1);
-        *ePBC = read_tpx(infile, NULL, box, &natoms,
-                         (x == NULL) ? NULL : *x, (v == NULL) ? NULL : *v, NULL, mtop);
-        *top = gmx_mtop_t_to_t_topology(mtop);
-        /* In this case we need to throw away the group data too */
-        done_gmx_groups_t(&mtop->groups);
-        sfree(mtop);
-        std::strcpy(title, *top->name);
-        tpx_make_chain_identifiers(&top->atoms, &top->mols);
-    }
-    else
-    {
-        get_stx_coordnum(infile, &natoms);
-        init_t_atoms(&top->atoms, natoms, (fn2ftp(infile) == efPDB));
-        if (x == NULL)
-        {
-            snew(x, 1);
-            bXNULL = TRUE;
-        }
-        snew(*x, natoms);
-        if (v)
-        {
-            snew(*v, natoms);
-        }
-        read_stx_conf(infile, title, &top->atoms, *x, (v == NULL) ? NULL : *v, ePBC, box);
-        if (bXNULL)
-        {
-            sfree(*x);
-            sfree(x);
-        }
-        if (bMass)
-        {
-            aps = gmx_atomprop_init();
-            for (i = 0; (i < natoms); i++)
-            {
-                if (!gmx_atomprop_query(aps, epropMass,
-                                        *top->atoms.resinfo[top->atoms.atom[i].resind].name,
-                                        *top->atoms.atomname[i],
-                                        &(top->atoms.atom[i].m)))
-                {
-                    if (debug)
-                    {
-                        fprintf(debug, "Can not find mass for atom %s %d %s, setting to 1\n",
-                                *top->atoms.resinfo[top->atoms.atom[i].resind].name,
-                                top->atoms.resinfo[top->atoms.atom[i].resind].nr,
-                                *top->atoms.atomname[i]);
-                    }
-                }
-            }
-            gmx_atomprop_destroy(aps);
-        }
-        top->idef.ntypes = -1;
-    }
-
-    return bTop;
-}
index d85a8e3a0fea91241d0c8cf85b424637bf76850c..cec32f10f22ad86fb7bcda2db2b1506caf8d6ce1 100644 (file)
@@ -123,17 +123,6 @@ int read_tpx_top(const char *fn,
 gmx_bool fn2bTPX(const char *file);
 /* return if *file is one of the TPX file types */
 
-gmx_bool read_tps_conf(const char *infile, char *title, struct t_topology *top,
-                       int *ePBC, rvec **x, rvec **v, matrix box, gmx_bool bMass);
-/* Read title, top.atoms, x, v (if not NULL) and box from an STX file,
- * memory for atoms, x and v will be allocated.
- * Return TRUE if a complete topology was read.
- * If infile is a TPX file read the whole top,
- * else if bMass=TRUE, read the masses into top.atoms from the mass database.
- */
-
-void tpx_make_chain_identifiers(struct t_atoms *atoms, struct t_block *mols);
-
 #ifdef __cplusplus
 }
 #endif
index 78649cc2f5e3b0d16bd692b92b68a666726a79e2..1561d5a4468974757b6cfe2788e78f076b931f32 100644 (file)
@@ -38,7 +38,6 @@
 
 #include "eigio.h"
 
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trnio.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/utility/futil.h"
index 62b309d95c0f5357842d4071b06c589fe55f43e0..8daa582b6bcab93ca971c8dc94fc543addc07df3 100644 (file)
@@ -40,7 +40,7 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 7067df816010d366e954d8a2687b54288457f0c0..0b12224e2e98d91dd060b57cd2234bd4f4b744d1 100644 (file)
@@ -45,7 +45,6 @@
 #include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/matio.h"
 #include "gromacs/fileio/pdbio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/gmxana/gstat.h"
index f6da5c1243cbdc8223f5ebf77efeeabe611522b9..3a746b6eb330681bc4e570e07acf6a2c72b12530 100644 (file)
@@ -41,8 +41,8 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/matio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trnio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
index c8768b9227a0c2d8e6f4fb9b6ac885d079282b33..b4489a7e67ee7ca5060e22781f31ae6df80dcb1a 100644 (file)
@@ -43,7 +43,6 @@
 #include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/filenm.h"
 #include "gromacs/fileio/pdbio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/legacyheaders/macros.h"
 #include "gromacs/legacyheaders/txtdump.h"
index 3a91e57165d3bba7b802ea5a227f7e553844a379..107d87223055f1bb335e96f62d8c06d7623d18bc 100644 (file)
@@ -38,7 +38,7 @@
 #include <stdlib.h>
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 954e27cac8f4d2415fe2770f743b6345a1bd2e47..29bd719c4380249654e5134386405de7e8543bce 100644 (file)
@@ -42,7 +42,6 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index b32b789d0550aabacd134728e15ff17294475857..c88fa5da432006a76b5396a5530626e99b94a0bf 100644 (file)
@@ -40,8 +40,8 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/matio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/gmxana/gstat.h"
index 2cdf41e9feb09781c7465e8265f003240bcd00fa..a173e8291d9f833f5a40b56d5bf3b165b1bfad96 100644 (file)
@@ -43,6 +43,7 @@
 
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/correlationfunctions/autocorr.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/enxio.h"
 #include "gromacs/fileio/matio.h"
 #include "gromacs/fileio/trxio.h"
index 27748988b65e5a2f8a2937e0b56cc93202026f2b..cc33e1764130faae364939cabea2206a0680a2b5 100644 (file)
 #include <stdlib.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/matio.h"
 #include "gromacs/fileio/pdbio.h"
 #include "gromacs/fileio/strdb.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gstat.h"
index cb26f11be0dd05705b2c6955dc73fa5467b0b844..2f8e6c3b8e857dfd418395223c213e61e2332d51 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,2014, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015, 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.
@@ -40,7 +40,7 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/gmxana/princ.h"
index 2790a4213f8243f70129ec48b79f60cd0d63b73d..c7d980eee99a68d5b8a266427d420ef520f95c5b 100644 (file)
@@ -42,7 +42,6 @@
 
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/confio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/legacyheaders/force.h"
 #include "gromacs/legacyheaders/macros.h"
index 7d02832330e89f3b5134636b74e31519318b313c..6b2b93762622f64c75b2aae47ae60f17472a45cf 100644 (file)
@@ -41,7 +41,7 @@
 
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/correlationfunctions/autocorr.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 603b111b429fa54b37f911a2645d3e913bc63dd5..98e33e5c9a3fdd3a63a4bb3afe5fc07f5beb89ed 100644 (file)
@@ -39,8 +39,8 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/matio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/binsearch.h"
index aa95ade3eabf95d9178d445224e47620c1fce7f6..e33ddc7eead7e42dd8bd4a22a1b5e97462e1ddc5 100644 (file)
@@ -46,7 +46,6 @@
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/pdbio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/eigio.h"
 #include "gromacs/legacyheaders/macros.h"
index 5aeb6eb931c597adfe0557ad2501123de32a3cc6..8d2ac08527ab1a3d5367d54d667db66d3cfcfd83 100644 (file)
@@ -40,9 +40,9 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/filenm.h"
 #include "gromacs/fileio/matio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 82d7394ad47fddbe9143152ce5d9d087b6d38cd2..214ba9ef4099c7dfc095bb48d21773c5dadc37f6 100644 (file)
@@ -41,7 +41,7 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 1e288eac27c18e53c3957d445c9c054f2a6dfd08..3a6361d8969d93c6a82784dfbd9462c91f6cda5d 100644 (file)
@@ -41,7 +41,6 @@
 
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/confio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index ea0391982597ad6aed913f00b6e7d9e51d6e28be..4028f46b455d8e4995fb8c9a56c3cca099d8eeb3 100644 (file)
@@ -40,8 +40,8 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/pdbio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/gmxana/eigio.h"
 #include "gromacs/gmxana/gmx_ana.h"
index b20d0778844c389b90b68678b1d42962bf22b333..7e98f3de6d82b546f2774e30873d6caaf1f2ca62 100644 (file)
@@ -41,8 +41,8 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/pdbio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/gmxana/eigio.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 61293ef43294a29d6e964e27a3cdc2b06a58ff33..c0dded8283de35e32d686594ece504779146a3eb 100644 (file)
@@ -41,7 +41,6 @@
 
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/confio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/cmat.h"
index 5c2a808ae2f735ae1a3c41a50f062ba610edb3f4..68d10a239b6406adbe4b987f01e06689daa2d129 100644 (file)
@@ -40,7 +40,7 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 4a35277dc526007b2cee6ea1f49aa6e869adbcac..3e32fa29e142e02a984e85440a548b00b222b100 100644 (file)
@@ -40,8 +40,8 @@
 #include <stdlib.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/matio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/cmat.h"
index ddb5957837066e2919cc092d2d79191810b7c32e..ad79bb2945c448fc1ca38076119adaaa44d01afb 100644 (file)
@@ -39,9 +39,9 @@
 #include <math.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/matio.h"
 #include "gromacs/fileio/strdb.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 8cb4bf99a99de389b763652e94a38b28cbc79a9b..223a1d7d5995684f3ace3de3cb19a4dfedb0b48d 100644 (file)
@@ -41,7 +41,6 @@
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/pdbio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
@@ -225,7 +224,6 @@ int gmx_rmsf(int argc, char *argv[])
     int              step, nre, natoms, i, g, m, teller = 0;
     real             t, lambda, *w_rls, *w_rms;
 
-    t_tpxheader      header;
     t_inputrec       ir;
     t_topology       top;
     int              ePBC;
index c9f3dc16ee2dedb68ccd7db3d54dfaa786465e90..1c95da982faae63eb698031aee3a8ab67079aced 100644 (file)
@@ -38,7 +38,7 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 4b08d681a26bfa03c1687c190bf22b80bbb21a03..90d30a617a1718e45aa45c4102fc6725b21a2332 100644 (file)
@@ -38,7 +38,7 @@
 #include "config.h"
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index a12f14bfb80e3ffad06e1f3c240b4dad7684e8fd..ac01e53622643043d4b52931743c9c9ad6994fc9 100644 (file)
@@ -37,7 +37,7 @@
 #include "gmxpre.h"
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index cb3217179bfbdb2c2853ff11426fdd2a63f54ae8..a7f3d12720ba4f39634ae03d2cb1dc1bda3d2a4e 100644 (file)
@@ -38,7 +38,7 @@
 #include <stdlib.h>
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/legacyheaders/macros.h"
index a0993acb1f1b94af80f3b9d16b3fe23f92f4feaf..7560cec153d82974784b366b5e4c442401493380 100644 (file)
@@ -42,7 +42,6 @@
 
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/confio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index a651272a226dc4d5ff68fdc86fc150074797cb69..6f8463f63e58755937499a4b84245e3cdb939473 100644 (file)
@@ -46,7 +46,6 @@
 #include "gromacs/fileio/pdbio.h"
 #include "gromacs/fileio/tngio.h"
 #include "gromacs/fileio/tngio_for_tools.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trnio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xtcio.h"
index ea86375c9c989a439faa1f7d3eba3ea64e21c3f4..8b9e56ad9a7c0cf6721738911ed8338576216f13 100644 (file)
@@ -41,7 +41,7 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 595ada61aeb15b7e23c21920fb6975c7aa411b0c..8d046f4b6afa12190776315795c3abc443b5018a 100644 (file)
@@ -42,8 +42,8 @@
 #include <string.h>
 
 #include "gromacs/commandline/pargs.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/matio.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/gmxana/gmx_ana.h"
index 79c86b761c429d3e503533eb0cb9938af7678967..3fcb408faf15c8b9782a6fb0ba4a3d2e14266e96 100644 (file)
@@ -38,8 +38,8 @@
 
 #include "sfactor.h"
 
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/strdb.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xvgr.h"
 #include "gromacs/legacyheaders/macros.h"
index 26fb504dcdf318749f505c37aa4b78f48280198e..b98217255990bf1377a6a7a8a75cb9d28751019e 100644 (file)
@@ -45,7 +45,7 @@
 
 #include <cstring>
 
-#include "gromacs/fileio/tpxio.h"
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/trx.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/math/vec.h"
index 407682ed5cf6833e65284c49500aebabe9a10360..f7db22934184a287a8330d4c5f7f4c85e7b2a7f3 100644 (file)
@@ -45,8 +45,8 @@
 
 #include <string.h>
 
+#include "gromacs/fileio/confio.h"
 #include "gromacs/fileio/timecontrol.h"
-#include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trx.h"
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/legacyheaders/oenv.h"