Removed output_env_t, now using gmx_output_env_t * throughout.
authorDavid van der Spoel <spoel@xray.bmc.uu.se>
Thu, 1 Oct 2015 06:46:07 +0000 (08:46 +0200)
committerTeemu Murtola <teemu.murtola@gmail.com>
Fri, 2 Oct 2015 03:33:24 +0000 (06:33 +0300)
This patch removes types/oenv.h, and with that one more entry
from typedefs.h. Also removed some useless externs in swapcoords.cpp
and did some space cleanups.

Change-Id: I9a5fa11bcd5f4dc880b41bac94a552cbcd634b91

124 files changed:
src/gromacs/commandline/pargs.cpp
src/gromacs/commandline/pargs.h
src/gromacs/commandline/tests/pargs.cpp
src/gromacs/correlationfunctions/autocorr.cpp
src/gromacs/correlationfunctions/autocorr.h
src/gromacs/gmxana/anadih.cpp
src/gromacs/gmxana/cmat.cpp
src/gromacs/gmxana/cmat.h
src/gromacs/gmxana/dlist.cpp
src/gromacs/gmxana/gmx_anadock.cpp
src/gromacs/gmxana/gmx_anaeig.cpp
src/gromacs/gmxana/gmx_analyze.cpp
src/gromacs/gmxana/gmx_angle.cpp
src/gromacs/gmxana/gmx_bar.cpp
src/gromacs/gmxana/gmx_bundle.cpp
src/gromacs/gmxana/gmx_chi.cpp
src/gromacs/gmxana/gmx_cluster.cpp
src/gromacs/gmxana/gmx_clustsize.cpp
src/gromacs/gmxana/gmx_confrms.cpp
src/gromacs/gmxana/gmx_covar.cpp
src/gromacs/gmxana/gmx_current.cpp
src/gromacs/gmxana/gmx_density.cpp
src/gromacs/gmxana/gmx_densmap.cpp
src/gromacs/gmxana/gmx_densorder.cpp
src/gromacs/gmxana/gmx_dielectric.cpp
src/gromacs/gmxana/gmx_dipoles.cpp
src/gromacs/gmxana/gmx_disre.cpp
src/gromacs/gmxana/gmx_do_dssp.cpp
src/gromacs/gmxana/gmx_dos.cpp
src/gromacs/gmxana/gmx_dyecoupl.cpp
src/gromacs/gmxana/gmx_dyndom.cpp
src/gromacs/gmxana/gmx_editconf.cpp
src/gromacs/gmxana/gmx_eneconv.cpp
src/gromacs/gmxana/gmx_enemat.cpp
src/gromacs/gmxana/gmx_energy.cpp
src/gromacs/gmxana/gmx_filter.cpp
src/gromacs/gmxana/gmx_genion.cpp
src/gromacs/gmxana/gmx_genpr.cpp
src/gromacs/gmxana/gmx_gyrate.cpp
src/gromacs/gmxana/gmx_h2order.cpp
src/gromacs/gmxana/gmx_hbond.cpp
src/gromacs/gmxana/gmx_helix.cpp
src/gromacs/gmxana/gmx_helixorient.cpp
src/gromacs/gmxana/gmx_hydorder.cpp
src/gromacs/gmxana/gmx_lie.cpp
src/gromacs/gmxana/gmx_make_edi.cpp
src/gromacs/gmxana/gmx_make_ndx.cpp
src/gromacs/gmxana/gmx_mdmat.cpp
src/gromacs/gmxana/gmx_mindist.cpp
src/gromacs/gmxana/gmx_mk_angndx.cpp
src/gromacs/gmxana/gmx_morph.cpp
src/gromacs/gmxana/gmx_msd.cpp
src/gromacs/gmxana/gmx_nmeig.cpp
src/gromacs/gmxana/gmx_nmens.cpp
src/gromacs/gmxana/gmx_nmtraj.cpp
src/gromacs/gmxana/gmx_order.cpp
src/gromacs/gmxana/gmx_pme_error.cpp
src/gromacs/gmxana/gmx_polystat.cpp
src/gromacs/gmxana/gmx_potential.cpp
src/gromacs/gmxana/gmx_principal.cpp
src/gromacs/gmxana/gmx_rama.cpp
src/gromacs/gmxana/gmx_rms.cpp
src/gromacs/gmxana/gmx_rmsdist.cpp
src/gromacs/gmxana/gmx_rmsf.cpp
src/gromacs/gmxana/gmx_rotacf.cpp
src/gromacs/gmxana/gmx_rotmat.cpp
src/gromacs/gmxana/gmx_saltbr.cpp
src/gromacs/gmxana/gmx_sans.cpp
src/gromacs/gmxana/gmx_saxs.cpp
src/gromacs/gmxana/gmx_sham.cpp
src/gromacs/gmxana/gmx_sigeps.cpp
src/gromacs/gmxana/gmx_sorient.cpp
src/gromacs/gmxana/gmx_spatial.cpp
src/gromacs/gmxana/gmx_spol.cpp
src/gromacs/gmxana/gmx_tcaf.cpp
src/gromacs/gmxana/gmx_traj.cpp
src/gromacs/gmxana/gmx_trjcat.cpp
src/gromacs/gmxana/gmx_trjconv.cpp
src/gromacs/gmxana/gmx_trjorder.cpp
src/gromacs/gmxana/gmx_tune_pme.cpp
src/gromacs/gmxana/gmx_vanhove.cpp
src/gromacs/gmxana/gmx_velacc.cpp
src/gromacs/gmxana/gmx_wham.cpp
src/gromacs/gmxana/gmx_wheel.cpp
src/gromacs/gmxana/gmx_xpm2ps.cpp
src/gromacs/gmxana/gstat.h
src/gromacs/gmxana/nrama.cpp
src/gromacs/gmxana/nrama.h
src/gromacs/gmxana/sfactor.cpp
src/gromacs/gmxana/sfactor.h
src/gromacs/gmxpreprocess/genconf.cpp
src/gromacs/gmxpreprocess/grompp.cpp
src/gromacs/gmxpreprocess/pdb2gmx.cpp
src/gromacs/gmxpreprocess/readir.h
src/gromacs/gmxpreprocess/readpull.cpp
src/gromacs/gmxpreprocess/solvate.cpp
src/gromacs/gmxpreprocess/x2top.cpp
src/gromacs/imd/imd.cpp
src/gromacs/imd/imd.h
src/gromacs/legacyheaders/typedefs.h
src/gromacs/legacyheaders/types/oenv.h [deleted file]
src/gromacs/mdlib/integrator.h
src/gromacs/mdlib/minimize.cpp
src/gromacs/mdlib/sim_util.cpp
src/gromacs/mdlib/sim_util.h
src/gromacs/mdlib/tpi.cpp
src/gromacs/pulling/pull.cpp
src/gromacs/pulling/pull.h
src/gromacs/pulling/pull_rotation.cpp
src/gromacs/pulling/pull_rotation.h
src/gromacs/swap/swapcoords.cpp
src/gromacs/swap/swapcoords.h
src/gromacs/tools/check.cpp
src/gromacs/tools/compare.cpp
src/gromacs/tools/compare.h
src/gromacs/tools/convert_tpr.cpp
src/gromacs/tools/dump.cpp
src/programs/mdrun/md.cpp
src/programs/mdrun/mdrun.cpp
src/programs/mdrun/runner.cpp
src/programs/mdrun/runner.h
src/programs/view/manager.cpp
src/programs/view/manager.h
src/programs/view/view.cpp

index 353c979552df7a077ae034cb583f17dc9a5cb07c..585642a723551194b2f5e36cb8b761a91b79e656 100644 (file)
@@ -478,7 +478,7 @@ gmx_bool parse_common_args(int *argc, char *argv[], unsigned long Flags,
                            int nfile, t_filenm fnm[], int npargs, t_pargs *pa,
                            int ndesc, const char **desc,
                            int nbugs, const char **bugs,
-                           output_env_t *oenv)
+                           gmx_output_env_t **oenv)
 {
     /* This array should match the order of the enum in oenv.h */
     const char *const xvg_formats[] = { "xmgrace", "xmgr", "none" };
index dd24e1fc259dbd6feafcff73e0914e102f4fbbe9..e31672b026bd00eb44aa1b257fdcef6d03a5e441 100644 (file)
 
 #include "gromacs/fileio/filenm.h"
 #include "gromacs/fileio/oenv.h"
-#include "gromacs/legacyheaders/types/oenv.h"
 #include "gromacs/math/vectypes.h"
 #include "gromacs/utility/basedefinitions.h"
 #include "gromacs/utility/real.h"
 
 struct t_commrec;
+struct gmx_output_env_t;
 
 #ifdef __cplusplus
 extern "C"
@@ -262,7 +262,7 @@ gmx_bool parse_common_args(int *argc, char *argv[], unsigned long Flags,
                            int nfile, t_filenm fnm[], int npargs, t_pargs *pa,
                            int ndesc, const char **desc,
                            int nbugs, const char **bugs,
-                           output_env_t *oenv);
+                           gmx_output_env_t **oenv);
 
 /*! \} */
 
index 53ea895be10a4677c24204753d5ce2837f869932..cf6edc3d04f1a8f82885ff7841dfce05e4824c0c 100644 (file)
@@ -132,7 +132,7 @@ class ParseCommonArgsTest : public ::testing::Test
         CommandLine                 args_;
 
     private:
-        output_env_t                oenv_;
+        gmx_output_env_t           *oenv_;
         size_t                      fileCount_;
         gmx::test::TestFileManager  tempFiles_;
 };
index 66c0db1e6f2430fe9e615697a463120f47c53aff..ddbfd54fc5d0d917ed5641110c1ea707a6b70882 100644 (file)
@@ -522,7 +522,7 @@ void do_four_core(unsigned long mode, int nfour, int nf2, int nframes,
     }
 }
 
-void low_do_autocorr(const char *fn, const output_env_t oenv, const char *title,
+void low_do_autocorr(const char *fn, const gmx_output_env_t *oenv, const char *title,
                      int nframes, int nitem, int nout, real **c1,
                      real dt, unsigned long mode, int nrestart,
                      gmx_bool bAver, gmx_bool bNormalize,
@@ -773,7 +773,7 @@ t_pargs *add_acf_pargs(int *npargs, t_pargs *pa)
     return ppa;
 }
 
-void do_autocorr(const char *fn, const output_env_t oenv, const char *title,
+void do_autocorr(const char *fn, const gmx_output_env_t *oenv, const char *title,
                  int nframes, int nitem, real **c1,
                  real dt, unsigned long mode, gmx_bool bAver)
 {
index e408b6707690e042d72b4c078c28e591738e7e8b..8e5c67c1d9d5452c7206e9ba0b4a808d4d81f793 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014, by the GROMACS development team, led by
+ * Copyright (c) 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.
@@ -53,6 +53,8 @@
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/utility/real.h"
 
+struct gmx_output_env_t;
+
 #ifdef __cplusplus
 extern "C" {
 #endif
@@ -119,7 +121,7 @@ int get_acffitfn(void);
  * \param[in] bAver    If set, all ndih C(t) functions are averaged into a single
  *          C(t)
  */
-void do_autocorr(const char *fn, const output_env_t oenv,
+void do_autocorr(const char *fn, const gmx_output_env_t *oenv,
                  const char *title,
                  int nframes, int nitem, real **c1,
                  real dt, unsigned long mode, gmx_bool bAver);
@@ -173,7 +175,7 @@ void do_autocorr(const char *fn, const output_env_t oenv,
  * \param[in] tendfit Time to end fitting to the ACF
  * \param[in] nfitparm Number of fitting parameters in a multi-exponential fit
  */
-void low_do_autocorr(const char *fn, const output_env_t oenv,
+void low_do_autocorr(const char *fn, const gmx_output_env_t *oenv,
                      const char *title, int  nframes, int nitem,
                      int nout, real **c1, real dt, unsigned long mode,
                      int nrestart, gmx_bool bAver, gmx_bool bNormalize,
index c9de554bd298451d17b9f7d4e1b3c8fdc55f9d09..cb5bd1f0c3420a71c7fa6866e927985daaaeac3f 100644 (file)
@@ -55,7 +55,7 @@
 #include "gromacs/utility/fatalerror.h"
 #include "gromacs/utility/smalloc.h"
 
-void print_one(const output_env_t oenv, const char *base, const char *name,
+void print_one(const gmx_output_env_t *oenv, const char *base, const char *name,
                const char *title, const char *ylabel, int nf, real time[],
                real data[])
 {
@@ -132,7 +132,7 @@ static int calc_Nbin(real phi, int multiplicity, real core_frac)
 void ana_dih_trans(const char *fn_trans, const char *fn_histo,
                    real **dih, int nframes, int nangles,
                    const char *grpname, real *time, gmx_bool bRb,
-                   const output_env_t oenv)
+                   const gmx_output_env_t *oenv)
 {
     /* just a wrapper; declare extra args, then chuck away at end. */
     int      maxchi = 0;
@@ -161,7 +161,7 @@ void low_ana_dih_trans(gmx_bool bTrans, const char *fn_trans,
                        real **dih, int nlist, t_dlist dlist[], int nframes,
                        int nangles, const char *grpname, int multiplicity[],
                        real *time, gmx_bool bRb, real core_frac,
-                       const output_env_t oenv)
+                       const gmx_output_env_t *oenv)
 {
     FILE *fp;
     int  *tr_f, *tr_h;
@@ -450,7 +450,7 @@ void get_chi_product_traj (real **dih, int nframes, int nlist,
                            int maxchi, t_dlist dlist[], real time[],
                            int **lookup, int *multiplicity, gmx_bool bRb, gmx_bool bNormalize,
                            real core_frac, gmx_bool bAll, const char *fnall,
-                           const output_env_t oenv)
+                           const gmx_output_env_t *oenv)
 {
 
     gmx_bool bRotZero, bHaveChi = FALSE;
@@ -814,7 +814,7 @@ void read_ang_dih(const char *trj_fn,
                   real **trans_frac,
                   real **aver_angle,
                   real *dih[],
-                  const output_env_t oenv)
+                  const gmx_output_env_t *oenv)
 {
     struct t_pbc *pbc;
     t_trxstatus  *status;
index 6f48e44e7c7aed2df81a83127f6fc92b1266596e..f1c8baefbba6ace4396a20034cc275db85579e1f 100644 (file)
@@ -207,7 +207,7 @@ void swap_mat(t_mat *m)
 }
 
 void low_rmsd_dist(const char *fn, real maxrms, int nn, real **mat,
-                   const output_env_t oenv)
+                   const gmx_output_env_t *oenv)
 {
     FILE   *fp;
     int     i, j, *histo, x;
@@ -236,7 +236,7 @@ void low_rmsd_dist(const char *fn, real maxrms, int nn, real **mat,
     sfree(histo);
 }
 
-void rmsd_distribution(const char *fn, t_mat *rms, const output_env_t oenv)
+void rmsd_distribution(const char *fn, t_mat *rms, const gmx_output_env_t *oenv)
 {
     low_rmsd_dist(fn, rms->maxrms, rms->nn, rms->mat, oenv);
 }
index 63f6ca932d82a5585273545edfe6a4d5b3e2580f..b8d44263fab1845cce7a35611d67875166767a52 100644 (file)
 #ifndef _cmat_h
 #define _cmat_h
 
-#include "gromacs/legacyheaders/typedefs.h"
+#include "gromacs/utility/basedefinitions.h"
+#include "gromacs/utility/real.h"
+
+struct gmx_output_env_t;
 
 #ifdef __cplusplus
 extern "C"
@@ -85,9 +88,9 @@ extern real mat_energy(t_mat *mat);
 extern void swap_mat(t_mat *m);
 
 extern void low_rmsd_dist(const char *fn, real maxrms, int nn, real **mat,
-                          const output_env_t oenv);
+                          const gmx_output_env_t *oenv);
 
-extern void rmsd_distribution(const char *fn, t_mat *m, const output_env_t oenv);
+extern void rmsd_distribution(const char *fn, t_mat *m, const gmx_output_env_t *oenv);
 
 extern t_clustid *new_clustid(int n1);
 
index 41edf5fcbbf8dc938c137729223ea467d7d90d2f..173311a9459f1b8d5b9c51284c59e4b3f66195e7 100644 (file)
@@ -41,6 +41,7 @@
 
 #include "gromacs/gmxana/gstat.h"
 #include "gromacs/topology/residuetypes.h"
+#include "gromacs/topology/topology.h"
 #include "gromacs/utility/fatalerror.h"
 #include "gromacs/utility/smalloc.h"
 
index 31d918c1913ac3abe01634515b82e0871839eb93..9a20466442b12e8a070047e0b6b919d033b6c495 100644 (file)
@@ -177,7 +177,7 @@ static int pdbf_comp(const void *a, const void *b)
 }
 
 static void analyse_em_all(int npdb, t_pdbfile *pdbf[], const char *edocked,
-                           const char *efree, const output_env_t oenv)
+                           const char *efree, const gmx_output_env_t *oenv)
 {
     FILE *fp;
     int   i;
@@ -336,7 +336,7 @@ static void cluster_em_all(FILE *fp, int npdb, t_pdbfile *pdbf[],
 
 int gmx_anadock(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] analyses the results of an Autodock run and clusters the",
         "structures together, based on distance or RMSD. The docked energy",
         "and free energy estimates are analysed, and for each cluster the",
@@ -345,17 +345,17 @@ int gmx_anadock(int argc, char *argv[])
         "using [gmx-cluster] and then sort the clusters on either lowest",
         "energy or average energy."
     };
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efPDB, "-f", NULL,       ffREAD  },
         { efXVG, "-od", "edocked", ffWRITE },
         { efXVG, "-of", "efree",   ffWRITE },
         { efLOG, "-g",  "anadock", ffWRITE }
     };
-    output_env_t    oenv;
+    gmx_output_env_t *oenv;
 #define NFILE asize(fnm)
-    static gmx_bool bFree  = FALSE, bRMS = TRUE;
-    static real     cutoff = 0.2;
-    t_pargs         pa[]   = {
+    static gmx_bool   bFree  = FALSE, bRMS = TRUE;
+    static real       cutoff = 0.2;
+    t_pargs           pa[]   = {
         { "-free",   FALSE, etBOOL, {&bFree},
           "Use Free energy estimate from autodock for sorting the classes" },
         { "-rms",    FALSE, etBOOL, {&bRMS},
index a130f7d2c97d1abbe14be5cdc1e070c4904f46d5..92d5f55e5fb0665d7497aafa302d40e2e9b060ef 100644 (file)
@@ -149,7 +149,7 @@ static void write_xvgr_graphs(const char *file, int ngraphs, int nsetspergraph,
                               const char *xlabel, const char **ylabel,
                               int n, real *x, real **y, real ***sy,
                               real scale_x, gmx_bool bZero, gmx_bool bSplit,
-                              const output_env_t oenv)
+                              const gmx_output_env_t *oenv)
 {
     FILE *out;
     int   g, s, i;
@@ -460,7 +460,7 @@ static void overlap(const char *outfile, int natoms,
                     rvec **eigvec1,
                     int nvec2, int *eignr2, rvec **eigvec2,
                     int noutvec, int *outvec,
-                    const output_env_t oenv)
+                    const gmx_output_env_t *oenv)
 {
     FILE *out;
     int   i, v, vec, x;
@@ -507,7 +507,7 @@ static void project(const char *trajfile, t_topology *top, int ePBC, matrix topb
                     real *sqrtm, rvec *xav,
                     int *eignr, rvec **eigvec,
                     int noutvec, int *outvec, gmx_bool bSplit,
-                    const output_env_t oenv)
+                    const gmx_output_env_t *oenv)
 {
     FILE        *xvgrout = NULL;
     int          nat, i, j, d, v, vec, nfr, nframes = 0, snew_size, frame;
@@ -873,7 +873,7 @@ static void project(const char *trajfile, t_topology *top, int ePBC, matrix topb
 static void components(const char *outfile, int natoms,
                        int *eignr, rvec **eigvec,
                        int noutvec, int *outvec,
-                       const output_env_t oenv)
+                       const gmx_output_env_t *oenv)
 {
     int   g, s, v, i;
     real *x, ***y;
@@ -918,7 +918,7 @@ static void rmsf(const char *outfile, int natoms, real *sqrtm,
                  int *eignr, rvec **eigvec,
                  int noutvec, int *outvec,
                  real *eigval, int neig,
-                 const output_env_t oenv)
+                 const gmx_output_env_t *oenv)
 {
     int    g, v, i;
     real  *x, **y;
@@ -1067,36 +1067,36 @@ int gmx_anaeig(int argc, char *argv[])
     };
 #define NPA asize(pa)
 
-    t_topology     top;
-    int            ePBC  = -1;
-    t_atoms       *atoms = NULL;
-    rvec          *xtop, *xref1, *xref2, *xrefp = NULL;
-    gmx_bool       bDMR1, bDMA1, bDMR2, bDMA2;
-    int            nvec1, nvec2, *eignr1 = NULL, *eignr2 = NULL;
-    rvec          *xav1, *xav2, **eigvec1 = NULL, **eigvec2 = NULL;
-    matrix         topbox;
-    real           totmass, *sqrtm, *w_rls, t;
-    int            natoms;
-    char          *grpname;
-    const char    *indexfile;
-    int            i, j, d;
-    int            nout, *iout, noutvec, *outvec, nfit;
-    atom_id       *index = NULL, *ifit = NULL;
-    const char    *VecFile, *Vec2File, *topfile;
-    const char    *EigFile, *Eig2File;
-    const char    *CompFile, *RmsfFile, *ProjOnVecFile;
-    const char    *TwoDPlotFile, *ThreeDPlotFile;
-    const char    *FilterFile, *ExtremeFile;
-    const char    *OverlapFile, *InpMatFile;
-    gmx_bool       bFit1, bFit2, bM, bIndex, bTPS, bTop, bVec2, bProj;
-    gmx_bool       bFirstToLast, bFirstLastSet, bTraj, bCompare, bPDB3D;
-    real          *eigval1 = NULL, *eigval2 = NULL;
-    int            neig1, neig2;
-    double       **xvgdata;
-    output_env_t   oenv;
-    gmx_rmpbc_t    gpbc;
-
-    t_filenm       fnm[] = {
+    t_topology        top;
+    int               ePBC  = -1;
+    t_atoms          *atoms = NULL;
+    rvec             *xtop, *xref1, *xref2, *xrefp = NULL;
+    gmx_bool          bDMR1, bDMA1, bDMR2, bDMA2;
+    int               nvec1, nvec2, *eignr1 = NULL, *eignr2 = NULL;
+    rvec             *xav1, *xav2, **eigvec1 = NULL, **eigvec2 = NULL;
+    matrix            topbox;
+    real              totmass, *sqrtm, *w_rls, t;
+    int               natoms;
+    char             *grpname;
+    const char       *indexfile;
+    int               i, j, d;
+    int               nout, *iout, noutvec, *outvec, nfit;
+    atom_id          *index = NULL, *ifit = NULL;
+    const char       *VecFile, *Vec2File, *topfile;
+    const char       *EigFile, *Eig2File;
+    const char       *CompFile, *RmsfFile, *ProjOnVecFile;
+    const char       *TwoDPlotFile, *ThreeDPlotFile;
+    const char       *FilterFile, *ExtremeFile;
+    const char       *OverlapFile, *InpMatFile;
+    gmx_bool          bFit1, bFit2, bM, bIndex, bTPS, bTop, bVec2, bProj;
+    gmx_bool          bFirstToLast, bFirstLastSet, bTraj, bCompare, bPDB3D;
+    real             *eigval1 = NULL, *eigval2 = NULL;
+    int               neig1, neig2;
+    double          **xvgdata;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc;
+
+    t_filenm          fnm[] = {
         { efTRN, "-v",    "eigenvec",    ffREAD  },
         { efTRN, "-v2",   "eigenvec2",   ffOPTRD },
         { efTRX, "-f",    NULL,          ffOPTRD },
index 78f08aa7591ff2217e9026cbf73b5f4c6871b73d..6704ca6e93b3cb832f9c5e5d4b71fec11a4f31b1 100644 (file)
@@ -137,7 +137,7 @@ static real cosine_content(int nhp, int n, real *y)
 }
 
 static void plot_coscont(const char *ccfile, int n, int nset, real **val,
-                         const output_env_t oenv)
+                         const gmx_output_env_t *oenv)
 {
     FILE *fp;
     int   s;
@@ -239,7 +239,7 @@ static void regression_analysis(int n, gmx_bool bXYdy,
 }
 
 void histogram(const char *distfile, real binwidth, int n, int nset, real **val,
-               const output_env_t oenv)
+               const gmx_output_env_t *oenv)
 {
     FILE          *fp;
     int            i, s;
@@ -413,7 +413,7 @@ static real optimal_error_estimate(double sigma, double fitparm[], real tTotal)
 static void estimate_error(const char *eefile, int nb_min, int resol, int n,
                            int nset, double *av, double *sig, real **val, real dt,
                            gmx_bool bFitAc, gmx_bool bSingleExpFit, gmx_bool bAllowNegLTCorr,
-                           const output_env_t oenv)
+                           const gmx_output_env_t *oenv)
 {
     FILE    *fp;
     int      bs, prev_bs, nbs, nb;
@@ -797,7 +797,7 @@ static void filter(real flen, int n, int nset, real **val, real dt)
 
 static void do_fit(FILE *out, int n, gmx_bool bYdy,
                    int ny, real *x0, real **val,
-                   int npargs, t_pargs *ppa, const output_env_t oenv,
+                   int npargs, t_pargs *ppa, const gmx_output_env_t *oenv,
                    const char *fn_fitted)
 {
     real   *c1 = NULL, *sig = NULL;
@@ -900,16 +900,16 @@ static void do_fit(FILE *out, int n, gmx_bool bYdy,
     }
 }
 
-static void print_fitted_function(const char   *fitfile,
-                                  const char   *fn_fitted,
-                                  gmx_bool      bXYdy,
-                                  int           nset,
-                                  int           n,
-                                  real         *t,
-                                  real        **val,
-                                  int           npargs,
-                                  t_pargs      *ppa,
-                                  output_env_t  oenv)
+static void print_fitted_function(const char       *fitfile,
+                                  const char       *fn_fitted,
+                                  gmx_bool          bXYdy,
+                                  int               nset,
+                                  int               n,
+                                  real             *t,
+                                  real            **val,
+                                  int               npargs,
+                                  t_pargs          *ppa,
+                                  gmx_output_env_t *oenv)
 {
     FILE *out_fit = gmx_ffopen(fitfile, "w");
     if (bXYdy && nset >= 2)
@@ -1103,14 +1103,14 @@ int gmx_analyze(int argc, char *argv[])
     };
 #define NPA asize(pa)
 
-    FILE           *out;
-    int             n, nlast, s, nset, i, j = 0;
-    real          **val, *t, dt, tot, error;
-    double         *av, *sig, cum1, cum2, cum3, cum4, db;
-    const char     *acfile, *msdfile, *ccfile, *distfile, *avfile, *eefile, *fitfile;
-    output_env_t    oenv;
+    FILE             *out;
+    int               n, nlast, s, nset, i, j = 0;
+    real            **val, *t, dt, tot, error;
+    double           *av, *sig, cum1, cum2, cum3, cum4, db;
+    const char       *acfile, *msdfile, *ccfile, *distfile, *avfile, *eefile, *fitfile;
+    gmx_output_env_t *oenv;
 
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efXVG, "-f",    "graph",    ffREAD   },
         { efXVG, "-ac",   "autocorr", ffOPTWR  },
         { efXVG, "-msd",  "msd",      ffOPTWR  },
index fee1e387589106a237808a09c9aad9b4974c6db8..ec728a4961e0e89dad799233a80577c636dc59f2 100644 (file)
@@ -161,15 +161,15 @@ int gmx_g_angle(int argc, char *argv[])
     int                nframes, maxangstat, mult, *angstat;
     int                i, j, nangles, first, last;
     gmx_bool           bAver, bRb, bPeriodic,
-                       bFrac,          /* calculate fraction too?  */
-                       bTrans,         /* worry about transtions too? */
-                       bCorr;          /* correlation function ? */
-    real         aver, aver2, aversig; /* fraction trans dihedrals */
-    double       tfrac = 0;
-    char         title[256];
-    real       **dih = NULL;      /* mega array with all dih. angles at all times*/
-    real        *time, *trans_frac, *aver_angle;
-    t_filenm     fnm[] = {
+                       bFrac,               /* calculate fraction too?  */
+                       bTrans,              /* worry about transtions too? */
+                       bCorr;               /* correlation function ? */
+    real              aver, aver2, aversig; /* fraction trans dihedrals */
+    double            tfrac = 0;
+    char              title[256];
+    real            **dih = NULL; /* mega array with all dih. angles at all times*/
+    real             *time, *trans_frac, *aver_angle;
+    t_filenm          fnm[] = {
         { efTRX, "-f", NULL,  ffREAD  },
         { efNDX, NULL, "angle",  ffREAD  },
         { efXVG, "-od", "angdist",  ffWRITE },
@@ -181,9 +181,9 @@ int gmx_g_angle(int argc, char *argv[])
         { efTRR, "-or", NULL,       ffOPTWR }
     };
 #define NFILE asize(fnm)
-    int          npargs;
-    t_pargs     *ppa;
-    output_env_t oenv;
+    int               npargs;
+    t_pargs          *ppa;
+    gmx_output_env_t *oenv;
 
     npargs = asize(pa);
     ppa    = add_acf_pargs(&npargs, pa);
index 8465d55dfb5587c75be564b9486cd8dd66e42ef8..fdd11c4a1a488cc8f1a1e5db35a7d352d1849c65 100644 (file)
@@ -1023,7 +1023,7 @@ static void sample_coll_make_hist(sample_coll_t *sc, int **bin,
 
 /* write a collection of histograms to a file */
 void sim_data_histogram(sim_data_t *sd, const char *filename,
-                        int nbin_default, const output_env_t oenv)
+                        int nbin_default, const gmx_output_env_t *oenv)
 {
     char           label_x[STRLEN];
     const char    *dhdl    = "dH/d\\lambda", *deltag = "\\DeltaH", *lambda = "\\lambda";
@@ -3610,33 +3610,33 @@ int gmx_bar(int argc, char *argv[])
     };
 #define NFILE asize(fnm)
 
-    int          f;
-    int          nf = 0;    /* file counter */
-    int          nfile_tot; /* total number of input files */
-    int          nxvgfile = 0;
-    int          nedrfile = 0;
-    char       **fxvgnms;
-    char       **fedrnms;
-    sim_data_t   sim_data; /* the simulation data */
-    barres_t    *results;  /* the results */
-    int          nresults; /* number of results in results array */
-
-    double      *partsum;
-    double       prec, dg_tot;
-    FILE        *fpb, *fpi;
-    char         dgformat[20], xvg2format[STRLEN], xvg3format[STRLEN];
-    char         buf[STRLEN], buf2[STRLEN];
-    char         ktformat[STRLEN], sktformat[STRLEN];
-    char         kteformat[STRLEN], skteformat[STRLEN];
-    output_env_t oenv;
-    double       kT;
-    gmx_bool     result_OK = TRUE, bEE = TRUE;
-
-    gmx_bool     disc_err          = FALSE;
-    double       sum_disc_err      = 0.; /* discretization error */
-    gmx_bool     histrange_err     = FALSE;
-    double       sum_histrange_err = 0.; /* histogram range error */
-    double       stat_err          = 0.; /* statistical error */
+    int               f;
+    int               nf = 0;    /* file counter */
+    int               nfile_tot; /* total number of input files */
+    int               nxvgfile = 0;
+    int               nedrfile = 0;
+    char            **fxvgnms;
+    char            **fedrnms;
+    sim_data_t        sim_data; /* the simulation data */
+    barres_t         *results;  /* the results */
+    int               nresults; /* number of results in results array */
+
+    double           *partsum;
+    double            prec, dg_tot;
+    FILE             *fpb, *fpi;
+    char              dgformat[20], xvg2format[STRLEN], xvg3format[STRLEN];
+    char              buf[STRLEN], buf2[STRLEN];
+    char              ktformat[STRLEN], sktformat[STRLEN];
+    char              kteformat[STRLEN], skteformat[STRLEN];
+    gmx_output_env_t *oenv;
+    double            kT;
+    gmx_bool          result_OK = TRUE, bEE = TRUE;
+
+    gmx_bool          disc_err          = FALSE;
+    double            sum_disc_err      = 0.; /* discretization error */
+    gmx_bool          histrange_err     = FALSE;
+    double            sum_histrange_err = 0.; /* histogram range error */
+    double            stat_err          = 0.; /* statistical error */
 
     if (!parse_common_args(&argc, argv,
                            PCA_CAN_VIEW,
index 1bc43210d9d2a1d319861e51f5922704e6390798..7b38dddfb183f3d7b22f52f4b973650eb10f4ce3 100644 (file)
@@ -190,7 +190,7 @@ static void dump_axes(t_trxstatus *status, t_trxframe *fr, t_atoms *outat,
 
 int gmx_bundle(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] analyzes bundles of axes. The axes can be for instance",
         "helix axes. The program reads two index groups and divides both",
         "of them in [TT]-na[tt] parts. The centers of mass of these parts",
@@ -213,35 +213,35 @@ int gmx_bundle(int argc, char *argv[])
         "command line option [TT]-nmrpdb[tt], and type [TT]set axis true[tt] to",
         "display the reference axis."
     };
-    static int      n    = 0;
-    static gmx_bool bZ   = FALSE;
-    t_pargs         pa[] = {
+    static int        n    = 0;
+    static gmx_bool   bZ   = FALSE;
+    t_pargs           pa[] = {
         { "-na", FALSE, etINT, {&n},
           "Number of axes" },
         { "-z", FALSE, etBOOL, {&bZ},
           "Use the [IT]z[it]-axis as reference instead of the average axis" }
     };
-    FILE           *flen, *fdist, *fz, *ftilt, *ftiltr, *ftiltl;
-    FILE           *fkink = NULL, *fkinkr = NULL, *fkinkl = NULL;
-    t_trxstatus    *status;
-    t_trxstatus    *fpdb;
-    t_topology      top;
-    int             ePBC;
-    rvec           *xtop;
-    matrix          box;
-    t_trxframe      fr;
-    t_atoms         outatoms;
-    real            t, comp;
-    char           *grpname[MAX_ENDS];
+    FILE             *flen, *fdist, *fz, *ftilt, *ftiltr, *ftiltl;
+    FILE             *fkink = NULL, *fkinkr = NULL, *fkinkl = NULL;
+    t_trxstatus      *status;
+    t_trxstatus      *fpdb;
+    t_topology        top;
+    int               ePBC;
+    rvec             *xtop;
+    matrix            box;
+    t_trxframe        fr;
+    t_atoms           outatoms;
+    real              t, comp;
+    char             *grpname[MAX_ENDS];
     /* FIXME: The constness should not be cast away */
-    char           *anm = (char *)"CA", *rnm = (char *)"GLY";
-    int             i, gnx[MAX_ENDS];
-    atom_id        *index[MAX_ENDS];
-    t_bundle        bun;
-    gmx_bool        bKink;
-    rvec            va, vb, vc, vr, vl;
-    output_env_t    oenv;
-    gmx_rmpbc_t     gpbc = NULL;
+    char             *anm = (char *)"CA", *rnm = (char *)"GLY";
+    int               i, gnx[MAX_ENDS];
+    atom_id          *index[MAX_ENDS];
+    t_bundle          bun;
+    gmx_bool          bKink;
+    rvec              va, vb, vc, vr, vl;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
 
 #define NLEG asize(leg)
     t_filenm fnm[] = {
index bcad4616629a2be66e5a2069a4d1db31300f9a77..2b0ae8a56ce1de2bf9829c1e56a6b44c196b0cd0 100644 (file)
@@ -223,7 +223,7 @@ int bin(real chi, int mult)
 static void do_dihcorr(const char *fn, int nf, int ndih, real **dih, real dt,
                        int nlist, t_dlist dlist[], real time[], int maxchi,
                        gmx_bool bPhi, gmx_bool bPsi, gmx_bool bChi, gmx_bool bOmega,
-                       const output_env_t oenv)
+                       const gmx_output_env_t *oenv)
 {
     char name1[256], name2[256];
     int  i, j, Xi;
@@ -304,7 +304,7 @@ static void copy_dih_data(real in[], real out[], int nf, gmx_bool bLEAVE)
 static void dump_em_all(int nlist, t_dlist dlist[], int nf, real time[],
                         real **dih, int maxchi,
                         gmx_bool bPhi, gmx_bool bPsi, gmx_bool bChi, gmx_bool bOmega, gmx_bool bRAD,
-                        const output_env_t oenv)
+                        const gmx_output_env_t *oenv)
 {
     char  name[256], titlestr[256], ystr[256];
     real *data;
@@ -451,7 +451,7 @@ static void histogramming(FILE *log, int nbin, gmx_residuetype_t *rt,
                           gmx_bool bNormalize, gmx_bool bSSHisto, const char *ssdump,
                           real bfac_max, t_atoms *atoms,
                           gmx_bool bDo_jc, const char *fn,
-                          const output_env_t oenv)
+                          const gmx_output_env_t *oenv)
 {
     /* also gets 3J couplings and order parameters S2 */
     t_karplus kkkphi[] = {
@@ -846,7 +846,7 @@ static void histogramming(FILE *log, int nbin, gmx_residuetype_t *rt,
 }
 
 static FILE *rama_file(const char *fn, const char *title, const char *xaxis,
-                       const char *yaxis, const output_env_t oenv)
+                       const char *yaxis, const gmx_output_env_t *oenv)
 {
     FILE *fp;
 
@@ -884,7 +884,7 @@ static FILE *rama_file(const char *fn, const char *title, const char *xaxis,
 }
 
 static void do_rama(int nf, int nlist, t_dlist dlist[], real **dih,
-                    gmx_bool bViol, gmx_bool bRamOmega, const output_env_t oenv)
+                    gmx_bool bViol, gmx_bool bRamOmega, const gmx_output_env_t *oenv)
 {
     FILE    *fp, *gp = NULL;
     gmx_bool bOm;
@@ -1011,7 +1011,7 @@ static void do_rama(int nf, int nlist, t_dlist dlist[], real **dih,
 
 static void print_transitions(const char *fn, int maxchi, int nlist,
                               t_dlist dlist[], real dt,
-                              const output_env_t oenv)
+                              const gmx_output_env_t *oenv)
 {
     /* based on order_params below */
     FILE *fp;
@@ -1061,7 +1061,7 @@ static void order_params(FILE *log,
                          const char *fn, int maxchi, int nlist, t_dlist dlist[],
                          const char *pdbfn, real bfac_init,
                          t_atoms *atoms, rvec x[], int ePBC, matrix box,
-                         gmx_bool bPhi, gmx_bool bPsi, gmx_bool bChi, const output_env_t oenv)
+                         gmx_bool bPhi, gmx_bool bPsi, gmx_bool bChi, const gmx_output_env_t *oenv)
 {
     FILE *fp;
     int   nh[edMax];
@@ -1359,7 +1359,7 @@ int gmx_chi(int argc, char *argv[])
     gmx_bool           bChi, bCorr, bSSHisto;
     gmx_bool           bDo_rt, bDo_oh, bDo_ot, bDo_jc;
     real               dt = 0, traj_t_ns;
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     gmx_residuetype_t *rt;
 
     atom_id            isize, *index;
index c7fc0f595a1382a04b4ea81c8438f900207a37f1..356c386750a5bee8e3b788faf28b7d71282ef6f4 100644 (file)
@@ -150,7 +150,7 @@ void cp_index(int nn, int from[], int to[])
 void mc_optimize(FILE *log, t_mat *m, real *time,
                  int maxiter, int nrandom,
                  int seed, real kT,
-                 const char *conv, output_env_t oenv)
+                 const char *conv, gmx_output_env_t *oenv)
 {
     FILE      *fp = NULL;
     real       ecur, enext, emin, prob, enorm;
@@ -774,7 +774,7 @@ static void gromos(int n1, real **mat, real rmsdcut, t_clusters *clust)
 }
 
 rvec **read_whole_trj(const char *fn, int isize, atom_id index[], int skip,
-                      int *nframe, real **time, const output_env_t oenv, gmx_bool bPBC, gmx_rmpbc_t gpbc)
+                      int *nframe, real **time, const gmx_output_env_t *oenv, gmx_bool bPBC, gmx_rmpbc_t gpbc)
 {
     rvec       **xx, *x;
     matrix       box;
@@ -933,7 +933,7 @@ static char *parse_filename(const char *fn, int maxnr)
 
 static void ana_trans(t_clusters *clust, int nf,
                       const char *transfn, const char *ntransfn, FILE *log,
-                      t_rgb rlo, t_rgb rhi, const output_env_t oenv)
+                      t_rgb rlo, t_rgb rhi, const gmx_output_env_t *oenv)
 {
     FILE  *fp;
     real **trans, *axis;
@@ -1003,7 +1003,7 @@ static void analyze_clusters(int nf, t_clusters *clust, real **rmsd,
                              const char *clustidfn, gmx_bool bAverage,
                              int write_ncl, int write_nst, real rmsmin,
                              gmx_bool bFit, FILE *log, t_rgb rlo, t_rgb rhi,
-                             const output_env_t oenv)
+                             const gmx_output_env_t *oenv)
 {
     FILE        *size_fp = NULL;
     char         buf[STRLEN], buf1[40], buf2[40], buf3[40], *trxsfn;
@@ -1437,20 +1437,20 @@ int gmx_cluster(int argc, char *argv[])
         m_monte_carlo, m_diagonalize, m_gromos, m_nr
     };
     /* Set colors for plotting: white = zero RMS, black = maximum */
-    static t_rgb rlo_top  = { 1.0, 1.0, 1.0 };
-    static t_rgb rhi_top  = { 0.0, 0.0, 0.0 };
-    static t_rgb rlo_bot  = { 1.0, 1.0, 1.0 };
-    static t_rgb rhi_bot  = { 0.0, 0.0, 1.0 };
-    static int   nlevels  = 40, skip = 1;
-    static real  scalemax = -1.0, rmsdcut = 0.1, rmsmin = 0.0;
-    gmx_bool     bRMSdist = FALSE, bBinary = FALSE, bAverage = FALSE, bFit = TRUE;
-    static int   niter    = 10000, nrandom = 0, seed = 1993, write_ncl = 0, write_nst = 1, minstruct = 1;
-    static real  kT       = 1e-3;
-    static int   M        = 10, P = 3;
-    output_env_t oenv;
-    gmx_rmpbc_t  gpbc = NULL;
-
-    t_pargs      pa[] = {
+    static t_rgb      rlo_top  = { 1.0, 1.0, 1.0 };
+    static t_rgb      rhi_top  = { 0.0, 0.0, 0.0 };
+    static t_rgb      rlo_bot  = { 1.0, 1.0, 1.0 };
+    static t_rgb      rhi_bot  = { 0.0, 0.0, 1.0 };
+    static int        nlevels  = 40, skip = 1;
+    static real       scalemax = -1.0, rmsdcut = 0.1, rmsmin = 0.0;
+    gmx_bool          bRMSdist = FALSE, bBinary = FALSE, bAverage = FALSE, bFit = TRUE;
+    static int        niter    = 10000, nrandom = 0, seed = 1993, write_ncl = 0, write_nst = 1, minstruct = 1;
+    static real       kT       = 1e-3;
+    static int        M        = 10, P = 3;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
+
+    t_pargs           pa[] = {
         { "-dista", FALSE, etBOOL, {&bRMSdist},
           "Use RMSD of distances instead of RMS deviation" },
         { "-nlevels", FALSE, etINT,  {&nlevels},
@@ -1495,7 +1495,7 @@ int gmx_cluster(int argc, char *argv[])
         { "-pbc", FALSE, etBOOL,
           { &bPBC }, "PBC check" }
     };
-    t_filenm     fnm[] = {
+    t_filenm          fnm[] = {
         { efTRX, "-f",     NULL,        ffOPTRD },
         { efTPS, "-s",     NULL,        ffOPTRD },
         { efNDX, NULL,     NULL,        ffOPTRD },
index e762a4cbe00f313c3d6696b61f55dad9ae16fc99..15fb93f8cb91191eb5064634cc12fd1563cd6ab5 100644 (file)
@@ -68,7 +68,7 @@ static void clust_size(const char *ndx, const char *trx, const char *xpm,
                        const char *mcn, gmx_bool bMol, gmx_bool bPBC, const char *tpr,
                        real cut, int nskip, int nlevels,
                        t_rgb rmid, t_rgb rhi, int ndf,
-                       const output_env_t oenv)
+                       const gmx_output_env_t *oenv)
 {
     FILE                 *fp, *gp, *hp, *tp;
     atom_id              *index = NULL;
@@ -439,7 +439,7 @@ static void clust_size(const char *ndx, const char *trx, const char *xpm,
 
 int gmx_clustsize(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] computes the size distributions of molecular/atomic clusters in",
         "the gas phase. The output is given in the form of an [REF].xpm[ref] file.",
         "The total number of clusters is written to an [REF].xvg[ref] file.[PAR]",
@@ -458,18 +458,18 @@ int gmx_clustsize(int argc, char *argv[])
         "atom numbers of the largest cluster."
     };
 
-    static real     cutoff   = 0.35;
-    static int      nskip    = 0;
-    static int      nlevels  = 20;
-    static int      ndf      = -1;
-    static gmx_bool bMol     = FALSE;
-    static gmx_bool bPBC     = TRUE;
-    static rvec     rlo      = { 1.0, 1.0, 0.0 };
-    static rvec     rhi      = { 0.0, 0.0, 1.0 };
+    static real       cutoff   = 0.35;
+    static int        nskip    = 0;
+    static int        nlevels  = 20;
+    static int        ndf      = -1;
+    static gmx_bool   bMol     = FALSE;
+    static gmx_bool   bPBC     = TRUE;
+    static rvec       rlo      = { 1.0, 1.0, 0.0 };
+    static rvec       rhi      = { 0.0, 0.0, 1.0 };
 
-    output_env_t    oenv;
+    gmx_output_env_t *oenv;
 
-    t_pargs         pa[] = {
+    t_pargs           pa[] = {
         { "-cut",      FALSE, etREAL, {&cutoff},
           "Largest distance (nm) to be considered in a cluster" },
         { "-mol",      FALSE, etBOOL, {&bMol},
@@ -488,10 +488,10 @@ int gmx_clustsize(int argc, char *argv[])
           "RGB values for the color of the highest occupied cluster size" }
     };
 #define NPA asize(pa)
-    const char     *fnNDX, *fnTPR;
-    t_rgb           rgblo, rgbhi;
+    const char       *fnNDX, *fnTPR;
+    t_rgb             rgblo, rgbhi;
 
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efTRX, "-f",  NULL,         ffREAD  },
         { efTPR, NULL,  NULL,         ffOPTRD },
         { efNDX, NULL,  NULL,         ffOPTRD },
index 187e1b934cfba8667c59a25fbef55cde7382a237..aa049ed92c18a731eab483ea541b8580c79b1a27 100644 (file)
@@ -522,19 +522,19 @@ int gmx_confrms(int argc, char *argv[])
 #define NFILE asize(fnm)
 
     /* the two structure files */
-    const char  *conf1file, *conf2file, *matchndxfile, *outfile;
-    FILE        *fp;
-    char        *name1, *name2;
-    t_topology  *top1, *top2;
-    int          ePBC1, ePBC2;
-    t_atoms     *atoms1, *atoms2;
-    int          warn = 0;
-    atom_id      at;
-    real        *w_rls, mass, totmass;
-    rvec        *x1, *v1, *x2, *v2, *fit_x;
-    matrix       box1, box2;
-
-    output_env_t oenv;
+    const char       *conf1file, *conf2file, *matchndxfile, *outfile;
+    FILE             *fp;
+    char             *name1, *name2;
+    t_topology       *top1, *top2;
+    int               ePBC1, ePBC2;
+    t_atoms          *atoms1, *atoms2;
+    int               warn = 0;
+    atom_id           at;
+    real             *w_rls, mass, totmass;
+    rvec             *x1, *v1, *x2, *v2, *fit_x;
+    matrix            box1, box2;
+
+    gmx_output_env_t *oenv;
 
     /* counters */
     int     i, m;
index 6ba01d0ab5f441eeb35a2af17152ca9b5bf2413d..97460a0795ac22268055574f64c3b52a88e36280 100644 (file)
@@ -62,7 +62,7 @@
 
 int gmx_covar(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] calculates and diagonalizes the (mass-weighted)",
         "covariance matrix.",
         "All structures are fitted to the structure in the structure file.",
@@ -95,9 +95,9 @@ int gmx_covar(int argc, char *argv[])
         "should consider carefully whether a reduced set of atoms will meet",
         "your needs for lower costs."
     };
-    static gmx_bool bFit = TRUE, bRef = FALSE, bM = FALSE, bPBC = TRUE;
-    static int      end  = -1;
-    t_pargs         pa[] = {
+    static gmx_bool   bFit = TRUE, bRef = FALSE, bM = FALSE, bPBC = TRUE;
+    static int        end  = -1;
+    t_pargs           pa[] = {
         { "-fit",  FALSE, etBOOL, {&bFit},
           "Fit to a reference structure"},
         { "-ref",  FALSE, etBOOL, {&bRef},
@@ -109,34 +109,34 @@ int gmx_covar(int argc, char *argv[])
         { "-pbc",  FALSE,  etBOOL, {&bPBC},
           "Apply corrections for periodic boundary conditions" }
     };
-    FILE           *out = NULL; /* initialization makes all compilers happy */
-    t_trxstatus    *status;
-    t_topology      top;
-    int             ePBC;
-    t_atoms        *atoms;
-    rvec           *x, *xread, *xref, *xav, *xproj;
-    matrix          box, zerobox;
-    real           *sqrtm, *mat, *eigenvalues, sum, trace, inv_nframes;
-    real            t, tstart, tend, **mat2;
-    real            xj, *w_rls = NULL;
-    real            min, max, *axis;
-    int             natoms, nat, nframes0, nframes, nlevels;
-    gmx_int64_t     ndim, i, j, k, l;
-    int             WriteXref;
-    const char     *fitfile, *trxfile, *ndxfile;
-    const char     *eigvalfile, *eigvecfile, *averfile, *logfile;
-    const char     *asciifile, *xpmfile, *xpmafile;
-    char            str[STRLEN], *fitname, *ananame;
-    int             d, dj, nfit;
-    atom_id        *index, *ifit;
-    gmx_bool        bDiffMass1, bDiffMass2;
-    char            timebuf[STRLEN];
-    t_rgb           rlo, rmi, rhi;
-    real           *eigenvectors;
-    output_env_t    oenv;
-    gmx_rmpbc_t     gpbc = NULL;
-
-    t_filenm        fnm[] = {
+    FILE             *out = NULL; /* initialization makes all compilers happy */
+    t_trxstatus      *status;
+    t_topology        top;
+    int               ePBC;
+    t_atoms          *atoms;
+    rvec             *x, *xread, *xref, *xav, *xproj;
+    matrix            box, zerobox;
+    real             *sqrtm, *mat, *eigenvalues, sum, trace, inv_nframes;
+    real              t, tstart, tend, **mat2;
+    real              xj, *w_rls = NULL;
+    real              min, max, *axis;
+    int               natoms, nat, nframes0, nframes, nlevels;
+    gmx_int64_t       ndim, i, j, k, l;
+    int               WriteXref;
+    const char       *fitfile, *trxfile, *ndxfile;
+    const char       *eigvalfile, *eigvecfile, *averfile, *logfile;
+    const char       *asciifile, *xpmfile, *xpmafile;
+    char              str[STRLEN], *fitname, *ananame;
+    int               d, dj, nfit;
+    atom_id          *index, *ifit;
+    gmx_bool          bDiffMass1, bDiffMass2;
+    char              timebuf[STRLEN];
+    t_rgb             rlo, rmi, rhi;
+    real             *eigenvectors;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
+
+    t_filenm          fnm[] = {
         { efTRX, "-f",  NULL, ffREAD },
         { efTPS, NULL,  NULL, ffREAD },
         { efNDX, NULL,  NULL, ffOPTRD },
index 9225b1f7ea353115a378f7d7b0c5a54c969ca64c..79fa04859465e5c82f957244936693dd949c9c35 100644 (file)
@@ -351,7 +351,7 @@ static void dielectric(FILE *fmj, FILE *fmd, FILE *outf, FILE *fcur, FILE *mcor,
                        real bfit, real efit, real bvit, real evit,
                        t_trxstatus *status, int isize, int nmols, int nshift,
                        atom_id *index0, int indexm[], real mass2[],
-                       real qmol[], real eps_rf, const output_env_t oenv)
+                       real qmol[], real eps_rf, const gmx_output_env_t *oenv)
 {
     int       i, j;
     int       valloc, nalloc, nfr, nvfr;
@@ -803,7 +803,7 @@ int gmx_current(int argc, char *argv[])
           "Temperature for calculating epsilon."}
     };
 
-    output_env_t           oenv;
+    gmx_output_env_t      *oenv;
     t_topology             top;
     char                 **grpname = NULL;
     const char            *indexfn;
index 9ad6ede779ca10278146300af04f932702a51c4e..a4572f127452d3f3fd98839780e35a2f22ee15e5 100644 (file)
@@ -173,7 +173,7 @@ void calc_electron_density(const char *fn, atom_id **index, int gnx[],
                            int axis, int nr_grps, real *slWidth,
                            t_electron eltab[], int nr, gmx_bool bCenter,
                            atom_id *index_center, int ncenter,
-                           gmx_bool bRelative, const output_env_t oenv)
+                           gmx_bool bRelative, const gmx_output_env_t *oenv)
 {
     rvec        *x0;            /* coordinates without pbc */
     matrix       box;           /* box (3x3) */
@@ -330,7 +330,7 @@ void calc_density(const char *fn, atom_id **index, int gnx[],
                   double ***slDensity, int *nslices, t_topology *top, int ePBC,
                   int axis, int nr_grps, real *slWidth, gmx_bool bCenter,
                   atom_id *index_center, int ncenter,
-                  gmx_bool bRelative, const output_env_t oenv)
+                  gmx_bool bRelative, const gmx_output_env_t *oenv)
 {
     rvec        *x0;            /* coordinates without pbc */
     matrix       box;           /* box (3x3) */
@@ -479,7 +479,7 @@ void plot_density(double *slDensity[], const char *afile, int nslices,
                   int nr_grps, char *grpname[], real slWidth,
                   const char **dens_opt,
                   gmx_bool bCenter, gmx_bool bRelative, gmx_bool bSymmetrize,
-                  const output_env_t oenv)
+                  const gmx_output_env_t *oenv)
 {
     FILE       *den;
     const char *title  = NULL;
@@ -619,7 +619,7 @@ int gmx_density(int argc, char *argv[])
         "",
     };
 
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     static const char *dens_opt[] =
     { NULL, "mass", "number", "charge", "electron", NULL };
     static int         axis        = 2;  /* normal to memb. default z  */
index 257fa8e386c2c49cee473c6c589a11e9b4b1893b..4ffcb8f3c3dafdcffa566ecbc39da3cdeb5115e2 100644 (file)
@@ -146,7 +146,7 @@ int gmx_densmap(int argc, char *argv[])
     real               invspa = 0, invspz = 0, axial, r, vol_old, vol, rowsum;
     int                nlev   = 51;
     t_rgb              rlo    = {1, 1, 1}, rhi = {0, 0, 0};
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     const char        *label[] = { "x (nm)", "y (nm)", "z (nm)" };
     t_filenm           fnm[]   = {
         { efTRX, "-f",   NULL,       ffREAD },
index 8f64e791d0fb7af71cb1441cb79392550db58e55..8ea665665f3a95ddc260d889d09bcf5645c37bc1 100644 (file)
@@ -101,7 +101,7 @@ static void center_coords(t_atoms *atoms, matrix box, rvec x0[], int axis)
 }
 
 
-static void density_in_time (const char *fn, atom_id **index, int gnx[], real bw, real bwz, int nsttblock, real *****Densdevel, int *xslices, int *yslices, int *zslices, int *tblock, t_topology *top, int ePBC, int axis, gmx_bool bCenter, gmx_bool bps1d, const output_env_t oenv)
+static void density_in_time (const char *fn, atom_id **index, int gnx[], real bw, real bwz, int nsttblock, real *****Densdevel, int *xslices, int *yslices, int *zslices, int *tblock, t_topology *top, int ePBC, int axis, gmx_bool bCenter, gmx_bool bps1d, const gmx_output_env_t *oenv)
 
 {
 /*
@@ -347,7 +347,7 @@ static void filterdensmap(real ****Densmap, int xslices, int yslices, int zslice
 static void interfaces_txy (real ****Densmap, int xslices, int yslices, int zslices,
                             int tblocks, real binwidth, int method,
                             real dens1, real dens2, t_interf ****intf1,
-                            t_interf ****intf2, const output_env_t oenv)
+                            t_interf ****intf2, const gmx_output_env_t *oenv)
 {
     /*Returns two pointers to 3D arrays of t_interf structs containing (position,thickness) of the interface(s)*/
     FILE         *xvg;
@@ -610,7 +610,7 @@ static void writesurftoxpms(t_interf ***surf1, t_interf ***surf2, int tblocks, i
 
 static void writeraw(t_interf ***int1, t_interf ***int2, int tblocks,
                      int xbins, int ybins, char **fnms,
-                     const output_env_t oenv)
+                     const gmx_output_env_t *oenv)
 {
     FILE *raw1, *raw2;
     int   i, j, n;
@@ -665,7 +665,7 @@ int gmx_densorder(int argc, char *argv[])
      * options when running the program, without mentioning them here!
      */
 
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     t_topology        *top;
     char             **grpname;
     int                ePBC, *ngx;
index 13e3a8dd01c30e0949cb4f528d84bca5dc7757f2..c0d1500fcf5c1ba7704bda1cb0f64afcf850fe6f 100644 (file)
@@ -153,7 +153,7 @@ real numerical_deriv(int nx, real x[], real y[], real fity[], real combined[], r
 }
 
 void do_four(const char *fn, const char *cn, int nx, real x[], real dy[],
-             real eps0, real epsRF, const output_env_t oenv)
+             real eps0, real epsRF, const gmx_output_env_t *oenv)
 {
     FILE      *fp, *cp;
     t_complex *tmp, gw, hw, kw;
@@ -243,7 +243,7 @@ void do_four(const char *fn, const char *cn, int nx, real x[], real dy[],
 
 int gmx_dielectric(int argc, char *argv[])
 {
-    const char  *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] calculates frequency dependent dielectric constants",
         "from the autocorrelation function of the total dipole moment in",
         "your simulation. This ACF can be generated by [gmx-dipoles].",
@@ -267,25 +267,25 @@ int gmx_dielectric(int argc, char *argv[])
         "For a pure exponential relaxation (Debye relaxation) the latter",
         "plot should be one half of a circle."
     };
-    t_filenm     fnm[] = {
+    t_filenm          fnm[] = {
         { efXVG, "-f", "dipcorr", ffREAD  },
         { efXVG, "-d", "deriv",  ffWRITE },
         { efXVG, "-o", "epsw",   ffWRITE },
         { efXVG, "-c", "cole",   ffWRITE }
     };
 #define NFILE asize(fnm)
-    output_env_t oenv;
-    int          i, j, nx, ny, nxtail, eFitFn, nfitparm;
-    real         dt, integral, fitintegral, fac, rffac;
-    double      *fitparms;
-    double     **yd;
-    real       **y;
-    const char  *legend[] = { "Correlation", "Std. Dev.", "Fit", "Combined", "Derivative" };
-    static int   fix      = 0, bX = 1, nsmooth = 3;
-    static real  tendInt  = 5.0, tbegin = 5.0, tend = 500.0;
-    static real  A        = 0.5, tau1 = 10.0, tau2 = 1.0, eps0 = 80, epsRF = 78.5, tail = 500.0;
-    real         lambda;
-    t_pargs      pa[] = {
+    gmx_output_env_t *oenv;
+    int               i, j, nx, ny, nxtail, eFitFn, nfitparm;
+    real              dt, integral, fitintegral, fac, rffac;
+    double           *fitparms;
+    double          **yd;
+    real            **y;
+    const char       *legend[] = { "Correlation", "Std. Dev.", "Fit", "Combined", "Derivative" };
+    static int        fix      = 0, bX = 1, nsmooth = 3;
+    static real       tendInt  = 5.0, tbegin = 5.0, tend = 500.0;
+    static real       A        = 0.5, tau1 = 10.0, tau2 = 1.0, eps0 = 80, epsRF = 78.5, tail = 500.0;
+    real              lambda;
+    t_pargs           pa[] = {
         { "-x1",  FALSE, etBOOL, {&bX},
           "use first column as [IT]x[it]-axis rather than first data set" },
         { "-eint", FALSE, etREAL, {&tendInt},
index de7964e5ce759862a32b2fc95db41616e45a0e27..53c23a8418d8e1d1b88c082e24a7fb5b69bf9abf 100644 (file)
@@ -333,7 +333,7 @@ static void print_cmap(const char *cmap, t_gkrbin *gb, int *nlevels)
 
 static void print_gkrbin(const char *fn, t_gkrbin *gb,
                          int ngrp, int nframes, real volume,
-                         const output_env_t oenv)
+                         const gmx_output_env_t *oenv)
 {
     /* We compute Gk(r), gOO and hOO according to
      * Nymand & Linse, JCP 112 (2000) pp 6386-6395.
@@ -660,7 +660,7 @@ static void update_slab_dipoles(int k0, int k1, rvec x[], rvec mu,
 
 static void dump_slab_dipoles(const char *fn, int idim, int nslice,
                               rvec slab_dipole[], matrix box, int nframes,
-                              const output_env_t oenv)
+                              const gmx_output_env_t *oenv)
 {
     FILE       *fp;
     char        buf[STRLEN];
@@ -740,7 +740,7 @@ static void do_dip(t_topology *top, int ePBC, real volume,
                    int  *gkatom,  int skip,
                    gmx_bool bSlab,    int nslices,
                    const char *axtitle, const char *slabfn,
-                   const output_env_t oenv)
+                   const gmx_output_env_t *oenv)
 {
     const char *leg_mtot[] = {
         "M\\sx \\N",
@@ -1500,7 +1500,7 @@ void dipole_atom2molindex(int *n, int *index, t_block *mols)
 }
 int gmx_dipoles(int argc, char *argv[])
 {
-    const char    *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] computes the total dipole plus fluctuations of a simulation",
         "system. From this you can compute e.g. the dielectric constant for",
         "low-dielectric media.",
@@ -1537,16 +1537,16 @@ int gmx_dipoles(int argc, char *argv[])
         "an average dipole moment of the molecule of 2.273 (SPC). For the",
         "distribution function a maximum of 5.0 will be used."
     };
-    real           mu_max     = 5, mu_aver = -1, rcmax = 0;
-    real           epsilonRF  = 0.0, temp = 300;
-    gmx_bool       bPairs     = TRUE, bPhi = FALSE, bQuad = FALSE;
-    const char    *corrtype[] = {NULL, "none", "mol", "molsep", "total", NULL};
-    const char    *axtitle    = "Z";
-    int            nslices    = 10; /* nr of slices defined       */
-    int            skip       = 0, nFA = 0, nFB = 0, ncos = 1;
-    int            nlevels    = 20, ndegrees = 90;
-    output_env_t   oenv;
-    t_pargs        pa[] = {
+    real              mu_max     = 5, mu_aver = -1, rcmax = 0;
+    real              epsilonRF  = 0.0, temp = 300;
+    gmx_bool          bPairs     = TRUE, bPhi = FALSE, bQuad = FALSE;
+    const char       *corrtype[] = {NULL, "none", "mol", "molsep", "total", NULL};
+    const char       *axtitle    = "Z";
+    int               nslices    = 10; /* nr of slices defined       */
+    int               skip       = 0, nFA = 0, nFB = 0, ncos = 1;
+    int               nlevels    = 20, ndegrees = 90;
+    gmx_output_env_t *oenv;
+    t_pargs           pa[] = {
         { "-mu",       FALSE, etREAL, {&mu_aver},
           "dipole of a single molecule (in Debye)" },
         { "-mumax",    FALSE, etREAL, {&mu_max},
@@ -1582,12 +1582,12 @@ int gmx_dipoles(int argc, char *argv[])
         { "-ndegrees", FALSE, etINT, {&ndegrees},
           "Number of divisions on the [IT]y[it]-axis in the cmap output (for 180 degrees)" }
     };
-    int           *gnx;
-    int            nFF[2];
-    atom_id      **grpindex;
-    char         **grpname = NULL;
-    gmx_bool       bGkr, bMU, bSlab;
-    t_filenm       fnm[] = {
+    int              *gnx;
+    int               nFF[2];
+    atom_id         **grpindex;
+    char            **grpname = NULL;
+    gmx_bool          bGkr, bMU, bSlab;
+    t_filenm          fnm[] = {
         { efEDR, "-en", NULL,         ffOPTRD },
         { efTRX, "-f", NULL,           ffREAD },
         { efTPR, NULL, NULL,           ffREAD },
@@ -1605,12 +1605,12 @@ int gmx_dipoles(int argc, char *argv[])
         { efXVG, "-slab", "slab",       ffOPTWR }
     };
 #define NFILE asize(fnm)
-    int            npargs;
-    t_pargs       *ppa;
-    t_topology    *top;
-    int            ePBC;
-    int            k, natoms;
-    matrix         box;
+    int               npargs;
+    t_pargs          *ppa;
+    t_topology       *top;
+    int               ePBC;
+    int               k, natoms;
+    matrix            box;
 
     npargs = asize(pa);
     ppa    = add_acf_pargs(&npargs, pa);
index f053b91d448c5d6f293a65c65889fd51914d515c..0875cbe5db459b141b6a093db450d9b6f0c65fb9 100644 (file)
@@ -656,7 +656,7 @@ static void dump_disre_matrix(const char *fn, t_dr_result *dr, int ndr,
 
 int gmx_disre(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] computes violations of distance restraints.",
         "The program always",
         "computes the instantaneous violations rather than time-averaged,",
@@ -673,11 +673,11 @@ int gmx_disre(int argc, char *argv[])
         "the program will compute average violations using the third power",
         "averaging algorithm and print them in the log file."
     };
-    static int      ntop      = 0;
-    static int      nlevels   = 20;
-    static real     max_dr    = 0;
-    static gmx_bool bThird    = TRUE;
-    t_pargs         pa[]      = {
+    static int        ntop      = 0;
+    static int        nlevels   = 20;
+    static real       max_dr    = 0;
+    static gmx_bool   bThird    = TRUE;
+    t_pargs           pa[]      = {
         { "-ntop", FALSE, etINT,  {&ntop},
           "Number of large violations that are stored in the log file every step" },
         { "-maxdr", FALSE, etREAL, {&max_dr},
@@ -688,37 +688,37 @@ int gmx_disre(int argc, char *argv[])
           "Use inverse third power averaging or linear for matrix output" }
     };
 
-    FILE           *out = NULL, *aver = NULL, *numv = NULL, *maxxv = NULL, *xvg = NULL;
-    t_tpxheader     header;
-    t_inputrec      ir;
-    gmx_mtop_t      mtop;
-    rvec           *xtop;
-    gmx_localtop_t *top;
-    t_atoms        *atoms = NULL;
-    t_fcdata        fcd;
-    t_nrnb          nrnb;
-    t_graph        *g;
-    int             ntopatoms, natoms, i, j, kkk;
-    t_trxstatus    *status;
-    real            t;
-    rvec           *x, *f, *xav = NULL;
-    matrix          box;
-    gmx_bool        bPDB;
-    int             isize;
-    atom_id        *index = NULL, *ind_fit = NULL;
-    char           *grpname;
-    t_cluster_ndx  *clust = NULL;
-    t_dr_result     dr, *dr_clust = NULL;
-    char          **leg;
-    real           *vvindex = NULL, *w_rls = NULL;
-    t_mdatoms      *mdatoms;
-    t_pbc           pbc, *pbc_null;
-    int             my_clust;
-    FILE           *fplog;
-    output_env_t    oenv;
-    gmx_rmpbc_t     gpbc = NULL;
-
-    t_filenm        fnm[] = {
+    FILE             *out = NULL, *aver = NULL, *numv = NULL, *maxxv = NULL, *xvg = NULL;
+    t_tpxheader       header;
+    t_inputrec        ir;
+    gmx_mtop_t        mtop;
+    rvec             *xtop;
+    gmx_localtop_t   *top;
+    t_atoms          *atoms = NULL;
+    t_fcdata          fcd;
+    t_nrnb            nrnb;
+    t_graph          *g;
+    int               ntopatoms, natoms, i, j, kkk;
+    t_trxstatus      *status;
+    real              t;
+    rvec             *x, *f, *xav = NULL;
+    matrix            box;
+    gmx_bool          bPDB;
+    int               isize;
+    atom_id          *index = NULL, *ind_fit = NULL;
+    char             *grpname;
+    t_cluster_ndx    *clust = NULL;
+    t_dr_result       dr, *dr_clust = NULL;
+    char            **leg;
+    real             *vvindex = NULL, *w_rls = NULL;
+    t_mdatoms        *mdatoms;
+    t_pbc             pbc, *pbc_null;
+    int               my_clust;
+    FILE             *fplog;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
+
+    t_filenm          fnm[] = {
         { efTPR, NULL, NULL, ffREAD },
         { efTRX, "-f", NULL, ffREAD },
         { efXVG, "-ds", "drsum",  ffWRITE },
index e1cc068246140ffd5f5677034b1ad7bfffed7c15..3b900ff2dcecc94aff6eaf053facc40e4ba118f7 100644 (file)
@@ -65,7 +65,7 @@ static int strip_dssp(char *dsspfile, int nres,
                       gmx_bool bPhobres[], real t,
                       real *acc, FILE *fTArea,
                       t_matrix *mat, int average_area[],
-                      const output_env_t oenv)
+                      const gmx_output_env_t *oenv)
 {
     static gmx_bool bFirst = TRUE;
     static char    *ssbuf;
@@ -342,7 +342,7 @@ void write_sas_mat(const char *fn, real **accr, int nframe, int nres, t_matrix *
 }
 
 void analyse_ss(const char *outfile, t_matrix *mat, const char *ss_string,
-                const output_env_t oenv)
+                const gmx_output_env_t *oenv)
 {
     FILE        *fp;
     t_mapping   *map;
@@ -509,7 +509,7 @@ int gmx_do_dssp(int argc, char *argv[])
     char               pdbfile[32], tmpfile[32];
     char               dssp[256];
     const char        *dptr;
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     gmx_rmpbc_t        gpbc = NULL;
 
     t_filenm           fnm[] = {
index cf3f41232b5d8f653510fab5fe91644858ed3218..cef2d16969de6badef8a4d3a50097bb9be41c263 100644 (file)
@@ -276,7 +276,7 @@ int gmx_dos(int argc, char *argv[])
     int                 nV, nframes, n_alloc, i, j, fftcode, Nmol, Natom;
     double              rho, dt, Vsum, V, tmass, dostot, dos2;
     real              **c1, **dos, mi, beta, bfac, *nu, *tt, stddev, c1j;
-    output_env_t        oenv;
+    gmx_output_env_t   *oenv;
     gmx_fft_t           fft;
     double              cP, DiffCoeff, Delta, f, y, z, sigHS, Shs, Sig, DoS0, recip_fac;
     double              wCdiff, wSdiff, wAdiff, wEdiff;
index 0508b7c72e4f0c754ecb3362fa97651d82fa7ce9..d641e05a33b190fa55f229ef877cef9b6c2beee7 100644 (file)
@@ -71,12 +71,12 @@ int gmx_dyecoupl(int argc, char *argv[])
         "The [TT]-norm[tt] option (area-) normalizes the histograms."
     };
 
-    static gmx_bool bPBCdist = FALSE, bNormHist = FALSE;
-    int             histbins = 50;
-    output_env_t    oenv;
-    real            R0 = -1;
+    static gmx_bool   bPBCdist = FALSE, bNormHist = FALSE;
+    int               histbins = 50;
+    gmx_output_env_t *oenv;
+    real              R0 = -1;
 
-    t_pargs         pa[] =
+    t_pargs           pa[] =
     {
         { "-pbcdist", FALSE, etBOOL, { &bPBCdist }, "Distance R based on PBC" },
         { "-norm", FALSE, etBOOL, { &bNormHist }, "Normalize histograms" },
index 8ccb7143c8cfcffc58d708ffa567a7b0e84f5791..3ef57ec805b6577b5b59a6b04416b068c15e9e46 100644 (file)
@@ -147,7 +147,7 @@ static void rot_conf(t_atoms *atoms, rvec x[], rvec v[], real trans, real angle,
 
 int gmx_dyndom(int argc, char *argv[])
 {
-    const char  *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] reads a [REF].pdb[ref] file output from DynDom",
         "(http://www.cmp.uea.ac.uk/dyndom/).",
         "It reads the coordinates, the coordinates of the rotation axis,",
@@ -167,12 +167,12 @@ int gmx_dyndom(int argc, char *argv[])
         "inspection, and energy minimization may be necessary to",
         "validate the structure."
     };
-    static real  trans0 = 0;
-    static rvec  head   = { 0, 0, 0 };
-    static rvec  tail   = { 0, 0, 0 };
-    static real  angle0 = 0, angle1 = 0, maxangle = 0;
-    static int   label  = 0, nframes = 11;
-    t_pargs      pa[]   = {
+    static real       trans0 = 0;
+    static rvec       head   = { 0, 0, 0 };
+    static rvec       tail   = { 0, 0, 0 };
+    static real       angle0 = 0, angle1 = 0, maxangle = 0;
+    static int        label  = 0, nframes = 11;
+    t_pargs           pa[]   = {
         { "-firstangle",    FALSE, etREAL, {&angle0},
           "Angle of rotation about rotation vector" },
         { "-lastangle",    FALSE, etREAL, {&angle1},
@@ -188,16 +188,16 @@ int gmx_dyndom(int argc, char *argv[])
         { "-tail",     FALSE, etRVEC, {tail},
           "Last atom of the arrow vector" }
     };
-    int          i, j, natoms, isize;
-    t_trxstatus *status;
-    atom_id     *index = NULL, *index_all;
-    char        *grpname;
-    real         angle, trans;
-    rvec        *x, *v, *xout, *vout;
-    matrix       box;
-    output_env_t oenv;
+    int               i, j, natoms, isize;
+    t_trxstatus      *status;
+    atom_id          *index = NULL, *index_all;
+    char             *grpname;
+    real              angle, trans;
+    rvec             *x, *v, *xout, *vout;
+    matrix            box;
+    gmx_output_env_t *oenv;
 
-    t_filenm     fnm[] = {
+    t_filenm          fnm[] = {
         { efPDB, "-f", "dyndom",  ffREAD },
         { efTRO, "-o", "rotated", ffWRITE },
         { efNDX, "-n", "domains", ffREAD }
index f2545c71f59affc088de6415919623d231e0cc50..32979b936c04fa650c38289d91c4839cef59b051 100644 (file)
@@ -696,26 +696,26 @@ int gmx_editconf(int argc, char *argv[])
     };
 #define NPA asize(pa)
 
-    FILE          *out;
-    const char    *infile, *outfile;
-    int            outftp, inftp, natom, i, j, n_bfac, itype, ntype;
-    double        *bfac    = NULL, c6, c12;
-    int           *bfac_nr = NULL;
-    t_topology    *top     = NULL;
-    char          *grpname, *sgrpname, *agrpname;
-    int            isize, ssize, asize;
-    atom_id       *index, *sindex, *aindex;
-    rvec          *x, *v, gc, rmin, rmax, size;
-    int            ePBC;
-    matrix         box, rotmatrix, trans;
-    rvec           princd, tmpvec;
-    gmx_bool       bIndex, bSetSize, bSetAng, bDist, bSetCenter, bAlign;
-    gmx_bool       bHaveV, bScale, bRho, bTranslate, bRotate, bCalcGeom, bCalcDiam;
-    real           diam = 0, mass = 0, d, vdw;
-    gmx_atomprop_t aps;
-    gmx_conect     conect;
-    output_env_t   oenv;
-    t_filenm       fnm[] =
+    FILE             *out;
+    const char       *infile, *outfile;
+    int               outftp, inftp, natom, i, j, n_bfac, itype, ntype;
+    double           *bfac    = NULL, c6, c12;
+    int              *bfac_nr = NULL;
+    t_topology       *top     = NULL;
+    char             *grpname, *sgrpname, *agrpname;
+    int               isize, ssize, asize;
+    atom_id          *index, *sindex, *aindex;
+    rvec             *x, *v, gc, rmin, rmax, size;
+    int               ePBC;
+    matrix            box, rotmatrix, trans;
+    rvec              princd, tmpvec;
+    gmx_bool          bIndex, bSetSize, bSetAng, bDist, bSetCenter, bAlign;
+    gmx_bool          bHaveV, bScale, bRho, bTranslate, bRotate, bCalcGeom, bCalcDiam;
+    real              diam = 0, mass = 0, d, vdw;
+    gmx_atomprop_t    aps;
+    gmx_conect        conect;
+    gmx_output_env_t *oenv;
+    t_filenm          fnm[] =
     {
         { efSTX, "-f", NULL, ffREAD },
         { efNDX, "-n", NULL, ffOPTRD },
index acbe04cf9136b2393cdba028f503ee8cde3f80bb..85a00b6a87bf0202c16c290b9608f3ddc5229cf7 100644 (file)
@@ -494,7 +494,7 @@ static void update_ee_sum(int nre,
 
 int gmx_eneconv(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "With [IT]multiple files[it] specified for the [TT]-f[tt] option:[PAR]",
         "Concatenates several energy files in sorted order.",
         "In the case of double time frames, the one",
@@ -511,34 +511,34 @@ int gmx_eneconv(int argc, char *argv[])
         "[TT]-settime[tt] is applied first, then [TT]-dt[tt]/[TT]-offset[tt]",
         "followed by [TT]-b[tt] and [TT]-e[tt] to select which frames to write."
     };
-    const char     *bugs[] = {
+    const char       *bugs[] = {
         "When combining trajectories the sigma and E^2 (necessary for statistics) are not updated correctly. Only the actual energy is correct. One thus has to compute statistics in another way."
     };
-    ener_file_t     in  = NULL, out = NULL;
-    gmx_enxnm_t    *enm = NULL;
+    ener_file_t       in  = NULL, out = NULL;
+    gmx_enxnm_t      *enm = NULL;
 #if 0
-    ener_file_t     in, out = NULL;
-    gmx_enxnm_t    *enm = NULL;
+    ener_file_t       in, out = NULL;
+    gmx_enxnm_t      *enm = NULL;
 #endif
-    t_enxframe     *fr, *fro;
-    gmx_int64_t     ee_sum_step = 0, ee_sum_nsteps, ee_sum_nsum;
-    t_energy       *ee_sum;
-    gmx_int64_t     lastfilestep, laststep, startstep_file = 0;
-    int             noutfr;
-    int             nre, nremax, this_nre, nfile, f, i, kkk, nset, *set = NULL;
-    double          last_t;
-    char          **fnms;
-    real           *readtime, *settime, timestep, tadjust;
-    char            buf[22], buf2[22];
-    int            *cont_type;
-    gmx_bool        bNewFile, bFirst, bNewOutput;
-    output_env_t    oenv;
-    gmx_bool        warned_about_dh = FALSE;
-    t_enxblock     *blocks          = NULL;
-    int             nblocks         = 0;
-    int             nblocks_alloc   = 0;
-
-    t_filenm        fnm[] = {
+    t_enxframe       *fr, *fro;
+    gmx_int64_t       ee_sum_step = 0, ee_sum_nsteps, ee_sum_nsum;
+    t_energy         *ee_sum;
+    gmx_int64_t       lastfilestep, laststep, startstep_file = 0;
+    int               noutfr;
+    int               nre, nremax, this_nre, nfile, f, i, kkk, nset, *set = NULL;
+    double            last_t;
+    char            **fnms;
+    real             *readtime, *settime, timestep, tadjust;
+    char              buf[22], buf2[22];
+    int              *cont_type;
+    gmx_bool          bNewFile, bFirst, bNewOutput;
+    gmx_output_env_t *oenv;
+    gmx_bool          warned_about_dh = FALSE;
+    t_enxblock       *blocks          = NULL;
+    int               nblocks         = 0;
+    int               nblocks_alloc   = 0;
+
+    t_filenm          fnm[] = {
         { efEDR, "-f", NULL,    ffRDMULT },
         { efEDR, "-o", "fixed", ffWRITE  },
     };
index 81cf3c877e4ee745abd00dc7ca8f7fca48dedde5..53ee5db1c6f5be1192c1223d712989616c49e543 100644 (file)
@@ -148,32 +148,32 @@ int gmx_enemat(int argc, char *argv[])
        egTotal (total energy) */
 #define egTotal egNR
 #define egSP 1
-    gmx_bool       egrp_use[egNR+egSP];
-    ener_file_t    in;
-    FILE          *out;
-    int            timecheck = 0;
-    gmx_enxnm_t   *enm       = NULL;
-    t_enxframe    *fr;
-    int            teller = 0;
-    real           sum;
-    gmx_bool       bCont, bRef;
-    gmx_bool       bCutmax, bCutmin;
-    real         **eneset, *time = NULL;
-    int           *set, i, j, k, prevk, m = 0, n, nre, nset, nenergy;
-    char         **groups = NULL;
-    char           groupname[255], fn[255];
-    int            ngroups;
-    t_rgb          rlo, rhi, rmid;
-    real           emax, emid, emin;
-    real        ***emat, **etot, *groupnr;
-    double         beta, expE, **e, *eaver, *efree = NULL, edum;
-    char           label[234];
-    char         **ereflines, **erefres = NULL;
-    real          *eref  = NULL, *edif = NULL;
-    int            neref = 0;
-    output_env_t   oenv;
+    gmx_bool          egrp_use[egNR+egSP];
+    ener_file_t       in;
+    FILE             *out;
+    int               timecheck = 0;
+    gmx_enxnm_t      *enm       = NULL;
+    t_enxframe       *fr;
+    int               teller = 0;
+    real              sum;
+    gmx_bool          bCont, bRef;
+    gmx_bool          bCutmax, bCutmin;
+    real            **eneset, *time = NULL;
+    int              *set, i, j, k, prevk, m = 0, n, nre, nset, nenergy;
+    char            **groups = NULL;
+    char              groupname[255], fn[255];
+    int               ngroups;
+    t_rgb             rlo, rhi, rmid;
+    real              emax, emid, emin;
+    real           ***emat, **etot, *groupnr;
+    double            beta, expE, **e, *eaver, *efree = NULL, edum;
+    char              label[234];
+    char            **ereflines, **erefres = NULL;
+    real             *eref  = NULL, *edif = NULL;
+    int               neref = 0;
+    gmx_output_env_t *oenv;
 
-    t_filenm       fnm[] = {
+    t_filenm          fnm[] = {
         { efEDR, "-f", NULL, ffOPTRD },
         { efDAT, "-groups", "groups", ffREAD },
         { efDAT, "-eref",   "eref",   ffOPTRD },
index da925721b28aaf63e284cae71c9fb0795567149d..009b42947f173d8eb1f7b55293e2c2ae45865e96 100644 (file)
@@ -523,7 +523,7 @@ static void calc_violations(real rt[], real rav3[], int nb, int index[],
 static void analyse_disre(const char *voutfn,    int nframes,
                           real violaver[], real bounds[], int index[],
                           int pair[],      int nbounds,
-                          const output_env_t oenv)
+                          const gmx_output_env_t *oenv)
 {
     FILE   *vout;
     double  sum, sumt, sumaver;
@@ -575,7 +575,7 @@ static void analyse_disre(const char *voutfn,    int nframes,
 static void einstein_visco(const char *fn, const char *fni, int nsets,
                            int nint, real **eneint,
                            real V, real T, double dt,
-                           const output_env_t oenv)
+                           const gmx_output_env_t *oenv)
 {
     FILE  *fp0, *fp1;
     double av[4], avold[4];
@@ -1136,7 +1136,7 @@ static void analyse_ener(gmx_bool bCorr, const char *corrfn,
                          char **leg, gmx_enxnm_t *enm,
                          real Vaver, real ezero,
                          int nbmin, int nbmax,
-                         const output_env_t oenv)
+                         const gmx_output_env_t *oenv)
 {
     FILE           *fp;
     /* Check out the printed manual for equations! */
@@ -1468,7 +1468,7 @@ static void print1(FILE *fp, gmx_bool bDp, real e)
 static void fec(const char *ene2fn, const char *runavgfn,
                 real reftemp, int nset, int set[], char *leg[],
                 enerdata_t *edat, double time[],
-                const output_env_t oenv)
+                const gmx_output_env_t *oenv)
 {
     const char * ravgleg[] = {
         "\\8D\\4E = E\\sB\\N-E\\sA\\N",
@@ -1594,7 +1594,7 @@ static void fec(const char *ene2fn, const char *runavgfn,
 static void do_dhdl(t_enxframe *fr, t_inputrec *ir, FILE **fp_dhdl,
                     const char *filename, gmx_bool bDp,
                     int *blocks, int *hists, int *samples, int *nlambdas,
-                    const output_env_t oenv)
+                    const gmx_output_env_t *oenv)
 {
     const char  *dhdl = "dH/d\\lambda", *deltag = "\\DeltaH", *lambda = "\\lambda";
     char         title[STRLEN], label_x[STRLEN], label_y[STRLEN], legend[STRLEN];
@@ -2019,7 +2019,7 @@ int gmx_energy(int argc, char *argv[])
     int                resnr_j, resnr_k;
     const char        *orinst_sub = "@ subtitle \"instantaneous\"\n";
     char               buf[256];
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     t_enxblock        *blk       = NULL;
     t_enxblock        *blk_disre = NULL;
     int                ndisre    = 0;
index 0ad2f5195892e623af9ab1d86b06ddc1de64318a..fc3b8d66f9ba96df5fa6b9918dbc6c1d71aa4e4d 100644 (file)
@@ -54,7 +54,7 @@
 
 int gmx_filter(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] performs frequency filtering on a trajectory.",
         "The filter shape is cos([GRK]pi[grk] t/A) + 1 from -A to +A, where A is given",
         "by the option [TT]-nf[tt] times the time step in the input trajectory.",
@@ -78,9 +78,9 @@ int gmx_filter(int argc, char *argv[])
         "the coordinates in the structure file."
     };
 
-    static int      nf      = 10;
-    static gmx_bool bNoJump = TRUE, bFit = FALSE, bLowAll = FALSE;
-    t_pargs         pa[]    = {
+    static int        nf      = 10;
+    static gmx_bool   bNoJump = TRUE, bFit = FALSE, bLowAll = FALSE;
+    t_pargs           pa[]    = {
         { "-nf", FALSE, etINT, {&nf},
           "Sets the filter length as well as the output interval for low-pass filtering" },
         { "-all", FALSE, etBOOL, {&bLowAll},
@@ -90,24 +90,24 @@ int gmx_filter(int argc, char *argv[])
         { "-fit", FALSE, etBOOL, {&bFit},
           "Fit all frames to a reference structure" }
     };
-    const char     *topfile, *lowfile, *highfile;
-    gmx_bool        bTop = FALSE;
-    t_topology      top;
-    int             ePBC = -1;
-    rvec           *xtop;
-    matrix          topbox, *box, boxf;
-    char           *grpname;
-    int             isize;
-    atom_id        *index;
-    real           *w_rls = NULL;
-    t_trxstatus    *in;
-    t_trxstatus    *outl, *outh;
-    int             nffr, i, fr, nat, j, d, m;
-    atom_id        *ind;
-    real            flen, *filt, sum, *t;
-    rvec            xcmtop, xcm, **x, *ptr, *xf, *xn, *xp, hbox;
-    output_env_t    oenv;
-    gmx_rmpbc_t     gpbc = NULL;
+    const char       *topfile, *lowfile, *highfile;
+    gmx_bool          bTop = FALSE;
+    t_topology        top;
+    int               ePBC = -1;
+    rvec             *xtop;
+    matrix            topbox, *box, boxf;
+    char             *grpname;
+    int               isize;
+    atom_id          *index;
+    real             *w_rls = NULL;
+    t_trxstatus      *in;
+    t_trxstatus      *outl, *outh;
+    int               nffr, i, fr, nat, j, d, m;
+    atom_id          *ind;
+    real              flen, *filt, sum, *t;
+    rvec              xcmtop, xcm, **x, *ptr, *xf, *xn, *xp, hbox;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
 
 #define NLEG asize(leg)
     t_filenm fnm[] = {
index beb37ba3257cdd262197d4042c5403792e9881e6..b5ae29c1e963d4f94bede6989f36a457f1cf4973 100644 (file)
@@ -391,7 +391,7 @@ int gmx_genion(int argc, char *argv[])
     char              *grpname;
     gmx_bool          *bSet;
     int                i, nw, nwa, nsa, nsalt, iqtot;
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     gmx_rng_t          rng;
     t_filenm           fnm[] = {
         { efTPR, NULL,  NULL,      ffREAD  },
index 7ab52b774bf9a758f6e7c6c0a6a6662f42af3739..4576dbdd47af9f95587e2d34f4b6502252ef6392 100644 (file)
@@ -109,20 +109,20 @@ int gmx_genpr(int argc, char *argv[])
     };
 #define npargs asize(pa)
 
-    output_env_t     oenv;
-    t_atoms         *atoms = NULL;
-    int              i, j, k;
-    FILE            *out;
-    int              igrp;
-    real             d, dd, lo, hi;
-    atom_id         *ind_grp;
-    const char      *xfn, *nfn;
-    char            *gn_grp;
-    matrix           box;
-    gmx_bool         bFreeze;
-    rvec             dx, *x = NULL, *v = NULL;
+    gmx_output_env_t *oenv;
+    t_atoms          *atoms = NULL;
+    int               i, j, k;
+    FILE             *out;
+    int               igrp;
+    real              d, dd, lo, hi;
+    atom_id          *ind_grp;
+    const char       *xfn, *nfn;
+    char             *gn_grp;
+    matrix            box;
+    gmx_bool          bFreeze;
+    rvec              dx, *x = NULL, *v = NULL;
 
-    t_filenm         fnm[] = {
+    t_filenm          fnm[] = {
         { efSTX, "-f",  NULL,    ffREAD },
         { efNDX, "-n",  NULL,    ffOPTRD },
         { efITP, "-o",  "posre", ffWRITE },
index 3c93d1da71ebbb9d2ae4493425ee84954f16e3fe..adc5f5ba74e0ccf6050d63d9f54fb0b9e2c2b722 100644 (file)
@@ -175,7 +175,7 @@ void calc_gyro_z(rvec x[], matrix box,
 
 int gmx_gyrate(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] computes the radius of gyration of a molecule",
         "and the radii of gyration about the [IT]x[it]-, [IT]y[it]- and [IT]z[it]-axes,",
         "as a function of time. The atoms are explicitly mass weighted.[PAR]",
@@ -188,9 +188,9 @@ int gmx_gyrate(int argc, char *argv[])
         "With the option [TT]-nz[tt] 2D radii of gyration in the [IT]x-y[it] plane",
         "of slices along the [IT]z[it]-axis are calculated."
     };
-    static int      nmol = 1, nz = 0;
-    static gmx_bool bQ   = FALSE, bRot = FALSE, bMOI = FALSE;
-    t_pargs         pa[] = {
+    static int        nmol = 1, nz = 0;
+    static gmx_bool   bQ   = FALSE, bRot = FALSE, bMOI = FALSE;
+    t_pargs           pa[] = {
         { "-nmol", FALSE, etINT, {&nmol},
           "The number of molecules to analyze" },
         { "-q", FALSE, etBOOL, {&bQ},
@@ -202,28 +202,28 @@ int gmx_gyrate(int argc, char *argv[])
         { "-nz", FALSE, etINT, {&nz},
           "Calculate the 2D radii of gyration of this number of slices along the z-axis" },
     };
-    FILE           *out;
-    t_trxstatus    *status;
-    t_topology      top;
-    int             ePBC;
-    rvec           *x, *x_s;
-    rvec            xcm, gvec, gvec1;
-    matrix          box, trans;
-    gmx_bool        bACF;
-    real          **moi_trans = NULL;
-    int             max_moi   = 0, delta_moi = 100;
-    rvec            d, d1; /* eigenvalues of inertia tensor */
-    real            t, t0, tm, gyro;
-    int             natoms;
-    char           *grpname;
-    int             j, m, gnx, nam, mol;
-    atom_id        *index;
-    output_env_t    oenv;
-    gmx_rmpbc_t     gpbc   = NULL;
-    const char     *leg[]  = { "Rg", "Rg\\sX\\N", "Rg\\sY\\N", "Rg\\sZ\\N" };
-    const char     *legI[] = { "Itot", "I1", "I2", "I3" };
+    FILE             *out;
+    t_trxstatus      *status;
+    t_topology        top;
+    int               ePBC;
+    rvec             *x, *x_s;
+    rvec              xcm, gvec, gvec1;
+    matrix            box, trans;
+    gmx_bool          bACF;
+    real            **moi_trans = NULL;
+    int               max_moi   = 0, delta_moi = 100;
+    rvec              d, d1; /* eigenvalues of inertia tensor */
+    real              t, t0, tm, gyro;
+    int               natoms;
+    char             *grpname;
+    int               j, m, gnx, nam, mol;
+    atom_id          *index;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc   = NULL;
+    const char       *leg[]  = { "Rg", "Rg\\sX\\N", "Rg\\sY\\N", "Rg\\sZ\\N" };
+    const char       *legI[] = { "Itot", "I1", "I2", "I3" };
 #define NLEG asize(leg)
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efTRX, "-f",   NULL,       ffREAD },
         { efTPS, NULL,   NULL,       ffREAD },
         { efNDX, NULL,   NULL,       ffOPTRD },
@@ -231,8 +231,8 @@ int gmx_gyrate(int argc, char *argv[])
         { efXVG, "-acf", "moi-acf",  ffOPTWR },
     };
 #define NFILE asize(fnm)
-    int             npargs;
-    t_pargs        *ppa;
+    int               npargs;
+    t_pargs          *ppa;
 
     npargs = asize(pa);
     ppa    = add_acf_pargs(&npargs, pa);
index 61df819e2f61f0c35986b1dcf8dfd4ddba257bc7..b58bd4a21522f54578803bac8b61eb7b6636cf09 100644 (file)
@@ -67,7 +67,7 @@ void calc_h2order(const char *fn, atom_id index[], int ngx, rvec **slDipole,
                   real **slOrder, real *slWidth, int *nslices,
                   t_topology *top, int ePBC,
                   int axis, gmx_bool bMicel, atom_id micel[], int nmic,
-                  const output_env_t oenv)
+                  const gmx_output_env_t *oenv)
 {
     rvec *x0,            /* coordinates with pbc */
           dipole,        /* dipole moment due to one molecules */
@@ -233,7 +233,7 @@ void calc_h2order(const char *fn, atom_id index[], int ngx, rvec **slDipole,
 }
 
 void h2order_plot(rvec dipole[], real order[], const char *afile,
-                  int nslices, real slWidth, const output_env_t oenv)
+                  int nslices, real slWidth, const gmx_output_env_t *oenv)
 {
     FILE       *ord;              /* xvgr files with order parameters  */
     int         slice;            /* loop index     */
@@ -286,7 +286,7 @@ int gmx_h2order(int argc, char *argv[])
         "assigning molecules to slices is different."
     };
 
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     real              *slOrder,             /* av. cosine, per slice      */
                        slWidth = 0.0;       /* width of a slice           */
     rvec              *slDipole;
index 840d2d194b9261331f0c7b3ddbb14b7a7d944928..f01313a7d7fbb43e82273594fec16a4df431d8c3 100644 (file)
@@ -1509,7 +1509,7 @@ static void do_nhb_dist(FILE *fp, t_hbdata *hb, real t)
 }
 
 static void do_hblife(const char *fn, t_hbdata *hb, gmx_bool bMerge, gmx_bool bContact,
-                      const output_env_t oenv)
+                      const gmx_output_env_t *oenv)
 {
     FILE          *fp;
     const char    *leg[] = { "p(t)", "t p(t)" };
@@ -1917,7 +1917,7 @@ static void normalizeACF(real *ct, real *gt, int nhb, int len)
 
 static void do_hbac(const char *fn, t_hbdata *hb,
                     int nDump, gmx_bool bMerge, gmx_bool bContact, real fit_start,
-                    real temp, gmx_bool R2, const output_env_t oenv,
+                    real temp, gmx_bool R2, const gmx_output_env_t *oenv,
                     int nThreads)
 {
     FILE          *fp;
@@ -2187,9 +2187,9 @@ static void init_hbframe(t_hbdata *hb, int nframes, real t)
     }
 }
 
-static FILE *open_donor_properties_file(const char        *fn,
-                                        t_hbdata          *hb,
-                                        const output_env_t oenv)
+static FILE *open_donor_properties_file(const char             *fn,
+                                        t_hbdata               *hb,
+                                        const gmx_output_env_t *oenv)
 {
     FILE       *fp    = NULL;
     const char *leg[] = { "Nbound", "Nfree" };
@@ -2543,7 +2543,7 @@ int gmx_hbond(int argc, char *argv[])
     t_ncell              *icell, *jcell;
     ivec                  ngrid;
     unsigned char        *datable;
-    output_env_t          oenv;
+    gmx_output_env_t     *oenv;
     int                   ii, hh, actual_nThreads;
     int                   threadNr = 0;
     gmx_bool              bParallel;
index 862bc06f135497fcb5de0e3a221ed4ebcc386abc..38d484c7167f7f46c53b09948459f1ff9f344c8c 100644 (file)
@@ -120,7 +120,7 @@ int gmx_helix(int argc, char *argv[])
         real        val;
     } t_xvgrfile;
 
-    t_xvgrfile     xf[efhNR] = {
+    t_xvgrfile        xf[efhNR] = {
         { NULL, NULL, TRUE,  "radius",  "Helix radius",               NULL, "r (nm)", 0.0 },
         { NULL, NULL, TRUE,  "twist",   "Twist per residue",          NULL, "Angle (deg)", 0.0 },
         { NULL, NULL, TRUE,  "rise",    "Rise per residue",           NULL, "Rise (nm)", 0.0 },
@@ -140,22 +140,22 @@ int gmx_helix(int argc, char *argv[])
         { NULL, NULL, FALSE,  "helicity", "Helicity per Residue",     "Residue", "% of time", 0.0 }
     };
 
-    output_env_t   oenv;
-    char           buf[54];
-    t_trxstatus   *status;
-    int            natoms, nres;
-    t_bb          *bb;
-    int            i, j, nall, nbb, nca, teller;
-    atom_id       *bbindex, *caindex, *allindex;
-    t_topology    *top;
-    int            ePBC;
-    rvec          *x, *xref;
-    real           t;
-    real           rms;
-    matrix         box;
-    gmx_rmpbc_t    gpbc = NULL;
-    gmx_bool       bRange;
-    t_filenm       fnm[] = {
+    gmx_output_env_t *oenv;
+    char              buf[54];
+    t_trxstatus      *status;
+    int               natoms, nres;
+    t_bb             *bb;
+    int               i, j, nall, nbb, nca, teller;
+    atom_id          *bbindex, *caindex, *allindex;
+    t_topology       *top;
+    int               ePBC;
+    rvec             *x, *xref;
+    real              t;
+    real              rms;
+    matrix            box;
+    gmx_rmpbc_t       gpbc = NULL;
+    gmx_bool          bRange;
+    t_filenm          fnm[] = {
         { efTPR, NULL,  NULL,   ffREAD  },
         { efNDX, NULL,  NULL,   ffREAD  },
         { efTRX, "-f",  NULL,   ffREAD  },
index f74a664e7a01308856e3f79b89a3b956d1c11590..7590558e97979dc1a1a556e0624dd23a4fa5e58b 100644 (file)
@@ -56,7 +56,7 @@
 
 int gmx_helixorient(int argc, char *argv[])
 {
-    const char      *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] calculates the coordinates and direction of the average",
         "axis inside an alpha helix, and the direction/vectors of both the",
         "C[GRK]alpha[grk] and (optionally) a sidechain atom relative to the axis.[PAR]",
@@ -75,68 +75,68 @@ int gmx_helixorient(int argc, char *argv[])
         "purposes, we also write out the actual Euler rotation angles as [TT]theta[1-3].xvg[tt]"
     };
 
-    t_topology      *top = NULL;
-    real             t;
-    rvec            *x = NULL;
-    matrix           box;
-    t_trxstatus     *status;
-    int              natoms;
-    real             theta1, theta2, theta3;
-
-    int              i, j, teller = 0;
-    int              iCA, iSC;
-    atom_id         *ind_CA;
-    atom_id         *ind_SC;
-    char            *gn_CA;
-    char            *gn_SC;
-    rvec             v1, v2;
-    rvec            *x_CA, *x_SC;
-    rvec            *r12;
-    rvec            *r23;
-    rvec            *r34;
-    rvec            *diff13;
-    rvec            *diff24;
-    rvec            *helixaxis;
-    rvec            *residuehelixaxis;
-    rvec            *residueorigin;
-    rvec            *residuevector;
-    rvec            *sidechainvector;
-
-    rvec            *residuehelixaxis_t0;
-    rvec            *residuevector_t0;
-    rvec            *axis3_t0;
-    rvec            *residuehelixaxis_tlast;
-    rvec            *residuevector_tlast;
-    rvec            *axis3_tlast;
-    rvec             refaxes[3], newaxes[3];
-    rvec             unitaxes[3];
-    rvec             rot_refaxes[3], rot_newaxes[3];
-
-    real             tilt, rotation;
-    rvec            *axis3;
-    real            *twist, *residuetwist;
-    real            *radius, *residueradius;
-    real            *rise, *residuerise;
-    real            *residuebending;
-
-    real             tmp;
-    real             weight[3];
-    t_pbc            pbc;
-    matrix           A;
-
-    FILE            *fpaxis, *fpcenter, *fptilt, *fprotation;
-    FILE            *fpradius, *fprise, *fptwist;
-    FILE            *fptheta1, *fptheta2, *fptheta3;
-    FILE            *fpbending;
-    int              ePBC;
-
-    output_env_t     oenv;
-    gmx_rmpbc_t      gpbc = NULL;
-
-    static  gmx_bool bSC          = FALSE;
-    static gmx_bool  bIncremental = FALSE;
-
-    static t_pargs   pa[] = {
+    t_topology       *top = NULL;
+    real              t;
+    rvec             *x = NULL;
+    matrix            box;
+    t_trxstatus      *status;
+    int               natoms;
+    real              theta1, theta2, theta3;
+
+    int               i, j, teller = 0;
+    int               iCA, iSC;
+    atom_id          *ind_CA;
+    atom_id          *ind_SC;
+    char             *gn_CA;
+    char             *gn_SC;
+    rvec              v1, v2;
+    rvec             *x_CA, *x_SC;
+    rvec             *r12;
+    rvec             *r23;
+    rvec             *r34;
+    rvec             *diff13;
+    rvec             *diff24;
+    rvec             *helixaxis;
+    rvec             *residuehelixaxis;
+    rvec             *residueorigin;
+    rvec             *residuevector;
+    rvec             *sidechainvector;
+
+    rvec             *residuehelixaxis_t0;
+    rvec             *residuevector_t0;
+    rvec             *axis3_t0;
+    rvec             *residuehelixaxis_tlast;
+    rvec             *residuevector_tlast;
+    rvec             *axis3_tlast;
+    rvec              refaxes[3], newaxes[3];
+    rvec              unitaxes[3];
+    rvec              rot_refaxes[3], rot_newaxes[3];
+
+    real              tilt, rotation;
+    rvec             *axis3;
+    real             *twist, *residuetwist;
+    real             *radius, *residueradius;
+    real             *rise, *residuerise;
+    real             *residuebending;
+
+    real              tmp;
+    real              weight[3];
+    t_pbc             pbc;
+    matrix            A;
+
+    FILE             *fpaxis, *fpcenter, *fptilt, *fprotation;
+    FILE             *fpradius, *fprise, *fptwist;
+    FILE             *fptheta1, *fptheta2, *fptheta3;
+    FILE             *fpbending;
+    int               ePBC;
+
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
+
+    static  gmx_bool  bSC          = FALSE;
+    static gmx_bool   bIncremental = FALSE;
+
+    static t_pargs    pa[] = {
         { "-sidechain",      FALSE, etBOOL, {&bSC},
           "Calculate sidechain directions relative to helix axis too." },
         { "-incremental",        FALSE, etBOOL, {&bIncremental},
index 38c812281318a23dff6888d32db667a3b090674d..351d81b44589e2cb9a8b751867711756bed4018c 100644 (file)
@@ -274,7 +274,7 @@ static void find_tetra_order_grid(t_topology top, int ePBC,
 static void calc_tetra_order_interface(const char *fnNDX, const char *fnTPS, const char *fnTRX, real binw, int tblock,
                                        int *nframes,  int *nslicex, int *nslicey,
                                        real sgang1, real sgang2, real ****intfpos,
-                                       output_env_t oenv)
+                                       gmx_output_env_t *oenv)
 {
     FILE         *fpsg   = NULL, *fpsk = NULL;
     t_topology    top;
@@ -632,10 +632,10 @@ int gmx_hydorder(int argc, char *argv[])
 #define NFILE asize(fnm)
 
     /*Filenames*/
-    const char  *ndxfnm, *tpsfnm, *trxfnm;
-    char       **spectra, **intfn, **raw;
-    int          nfspect, nfxpm, nfraw;
-    output_env_t oenv;
+    const char       *ndxfnm, *tpsfnm, *trxfnm;
+    char            **spectra, **intfn, **raw;
+    int               nfspect, nfxpm, nfraw;
+    gmx_output_env_t *oenv;
 
     if (!parse_common_args(&argc, argv, PCA_CAN_VIEW | PCA_CAN_TIME,
                            NFILE, fnm, asize(pa), pa, asize(desc), desc, 0, NULL, &oenv))
index 5cfc00c1cd0eee9c16f2c27c3abf00e5cffeaddc..91dcb07464e23d14a87eabe1093dcbd9a2435429 100644 (file)
@@ -164,17 +164,17 @@ int gmx_lie(int argc, char *argv[])
     };
 #define NPA asize(pa)
 
-    FILE         *out;
-    int           nre, nframes = 0, ct = 0;
-    ener_file_t   fp;
-    t_liedata    *ld;
-    gmx_enxnm_t  *enm = NULL;
-    t_enxframe   *fr;
-    real          lie;
-    double        lieaver = 0, lieav2 = 0;
-    output_env_t  oenv;
-
-    t_filenm      fnm[] = {
+    FILE             *out;
+    int               nre, nframes = 0, ct = 0;
+    ener_file_t       fp;
+    t_liedata        *ld;
+    gmx_enxnm_t      *enm = NULL;
+    t_enxframe       *fr;
+    real              lie;
+    double            lieaver = 0, lieav2 = 0;
+    gmx_output_env_t *oenv;
+
+    t_filenm          fnm[] = {
         { efEDR, "-f",    "ener",     ffREAD   },
         { efXVG, "-o",    "lie",      ffWRITE  }
     };
index b5f94a1eecb044def5a291131415e12e6e391ce0..04252ce6c8bb3a5f72620d27321d3e5347aba31c 100644 (file)
@@ -723,26 +723,26 @@ int gmx_make_edi(int argc, char *argv[])
     };
 #define NPA asize(pa)
 
-    rvec        *xref1;
-    int          nvec1, *eignr1 = NULL;
-    rvec        *xav1, **eigvec1 = NULL;
-    t_atoms     *atoms = NULL;
-    int          nav; /* Number of atoms in the average structure */
-    char        *grpname;
-    const char  *indexfile;
-    int          i;
-    atom_id     *index, *ifit;
-    int          nfit;           /* Number of atoms in the reference/fit structure */
-    int          ev_class;       /* parameter _class i.e. evMON, evRADFIX etc. */
-    int          nvecs;
-    real        *eigval1 = NULL; /* in V3.3 this is parameter of read_eigenvectors */
-
-    const char  *EdiFile;
-    const char  *TargetFile;
-    const char  *OriginFile;
-    const char  *EigvecFile;
-
-    output_env_t oenv;
+    rvec             *xref1;
+    int               nvec1, *eignr1 = NULL;
+    rvec             *xav1, **eigvec1 = NULL;
+    t_atoms          *atoms = NULL;
+    int               nav; /* Number of atoms in the average structure */
+    char             *grpname;
+    const char       *indexfile;
+    int               i;
+    atom_id          *index, *ifit;
+    int               nfit;           /* Number of atoms in the reference/fit structure */
+    int               ev_class;       /* parameter _class i.e. evMON, evRADFIX etc. */
+    int               nvecs;
+    real             *eigval1 = NULL; /* in V3.3 this is parameter of read_eigenvectors */
+
+    const char       *EdiFile;
+    const char       *TargetFile;
+    const char       *OriginFile;
+    const char       *EigvecFile;
+
+    gmx_output_env_t *oenv;
 
     /*to read topology file*/
     t_topology  top;
index e652d8eed422c2629e7672de3ee7bb3dc07af76a..28a70e1ca6cd1cbafa467f4fd80f76e1ea46d622 100644 (file)
@@ -1539,20 +1539,20 @@ int gmx_make_ndx(int argc, char *argv[])
     };
 #define NPA asize(pa)
 
-    output_env_t oenv;
-    int          nndxin;
-    const char  *stxfile;
-    char       **ndxinfiles;
-    const char  *ndxoutfile;
-    gmx_bool     bNatoms;
-    int          i, j;
-    t_atoms     *atoms;
-    rvec        *x, *v;
-    int          ePBC;
-    matrix       box;
-    t_blocka    *block, *block2;
-    char       **gnames, **gnames2;
-    t_filenm     fnm[] = {
+    gmx_output_env_t *oenv;
+    int               nndxin;
+    const char       *stxfile;
+    char            **ndxinfiles;
+    const char       *ndxoutfile;
+    gmx_bool          bNatoms;
+    int               i, j;
+    t_atoms          *atoms;
+    rvec             *x, *v;
+    int               ePBC;
+    matrix            box;
+    t_blocka         *block, *block2;
+    char            **gnames, **gnames2;
+    t_filenm          fnm[] = {
         { efSTX, "-f", NULL,     ffOPTRD  },
         { efNDX, "-n", NULL,     ffOPTRDMULT },
         { efNDX, "-o", NULL,     ffWRITE }
index bbf6c2507544f0111cbc33f4539b224169b1ef2c..27ba3c940892c95bc7d4a9f8e0a2960aeffc37a5 100644 (file)
@@ -202,29 +202,29 @@ int gmx_mdmat(int argc, char *argv[])
     };
 #define NFILE asize(fnm)
 
-    FILE          *out = NULL, *fp;
-    t_topology     top;
-    int            ePBC;
-    t_atoms        useatoms;
-    int            isize;
-    atom_id       *index;
-    char          *grpname;
-    int           *rndx, *natm, prevres, newres;
-
-    int            i, j, nres, natoms, nframes, trxnat;
-    t_trxstatus   *status;
-    gmx_bool       bCalcN, bFrames;
-    real           t, ratio;
-    char           label[234];
-    t_rgb          rlo, rhi;
-    rvec          *x;
-    real         **mdmat, *resnr, **totmdmat;
-    int          **nmat, **totnmat;
-    real          *mean_n;
-    int           *tot_n;
-    matrix         box = {{0}};
-    output_env_t   oenv;
-    gmx_rmpbc_t    gpbc = NULL;
+    FILE             *out = NULL, *fp;
+    t_topology        top;
+    int               ePBC;
+    t_atoms           useatoms;
+    int               isize;
+    atom_id          *index;
+    char             *grpname;
+    int              *rndx, *natm, prevres, newres;
+
+    int               i, j, nres, natoms, nframes, trxnat;
+    t_trxstatus      *status;
+    gmx_bool          bCalcN, bFrames;
+    real              t, ratio;
+    char              label[234];
+    t_rgb             rlo, rhi;
+    rvec             *x;
+    real            **mdmat, *resnr, **totmdmat;
+    int             **nmat, **totnmat;
+    real             *mean_n;
+    int              *tot_n;
+    matrix            box = {{0}};
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
 
     if (!parse_common_args(&argc, argv, PCA_CAN_TIME, NFILE, fnm,
                            asize(pa), pa, asize(desc), desc, 0, NULL, &oenv))
index f2c2e6e67e4902021f96a17dcbba44593fddfca1..ed71d1f4c0bfa2e2ee66d76c86a234dad79338ab 100644 (file)
@@ -142,7 +142,7 @@ static void periodic_dist(int ePBC,
 static void periodic_mindist_plot(const char *trxfn, const char *outfn,
                                   t_topology *top, int ePBC,
                                   int n, atom_id index[], gmx_bool bSplit,
-                                  const output_env_t oenv)
+                                  const gmx_output_env_t *oenv)
 {
     FILE        *out;
     const char  *leg[5] = { "min per.", "max int.", "box1", "box2", "box3" };
@@ -330,7 +330,7 @@ void dist_plot(const char *fn, const char *afile, const char *dfile,
                int ng, atom_id *index[], int gnx[], char *grpn[], gmx_bool bSplit,
                gmx_bool bMin, int nres, atom_id *residue, gmx_bool bPBC, int ePBC,
                gmx_bool bGroup, gmx_bool bEachResEachTime, gmx_bool bPrintResName,
-               const output_env_t oenv)
+               const gmx_output_env_t *oenv)
 {
     FILE            *atm, *dist, *num;
     t_trxstatus     *trxout;
@@ -643,7 +643,7 @@ void dump_res(FILE *out, int nres, atom_id *resindex, atom_id index[])
 
 int gmx_mindist(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] computes the distance between one group and a number of",
         "other groups. Both the minimum distance",
         "(between any pair of atoms from the respective groups)",
@@ -663,12 +663,12 @@ int gmx_mindist(int argc, char *argv[])
         "Also [gmx-distance] and [gmx-pairdist] calculate distances."
     };
 
-    static gmx_bool bMat             = FALSE, bPI = FALSE, bSplit = FALSE, bMax = FALSE, bPBC = TRUE;
-    static gmx_bool bGroup           = FALSE;
-    static real     rcutoff          = 0.6;
-    static int      ng               = 1;
-    static gmx_bool bEachResEachTime = FALSE, bPrintResName = FALSE;
-    t_pargs         pa[]             = {
+    static gmx_bool   bMat             = FALSE, bPI = FALSE, bSplit = FALSE, bMax = FALSE, bPBC = TRUE;
+    static gmx_bool   bGroup           = FALSE;
+    static real       rcutoff          = 0.6;
+    static int        ng               = 1;
+    static gmx_bool   bEachResEachTime = FALSE, bPrintResName = FALSE;
+    t_pargs           pa[]             = {
         { "-matrix", FALSE, etBOOL, {&bMat},
           "Calculate half a matrix of group-group distances" },
         { "-max",    FALSE, etBOOL, {&bMax},
@@ -690,19 +690,19 @@ int gmx_mindist(int argc, char *argv[])
         { "-printresname",  FALSE, etBOOL, {&bPrintResName},
           "Write residue names" }
     };
-    output_env_t    oenv;
-    t_topology     *top  = NULL;
-    int             ePBC = -1;
-    rvec           *x;
-    matrix          box;
-    gmx_bool        bTop = FALSE;
-
-    int             i, nres = 0;
-    const char     *trxfnm, *tpsfnm, *ndxfnm, *distfnm, *numfnm, *atmfnm, *oxfnm, *resfnm;
-    char          **grpname;
-    int            *gnx;
-    atom_id       **index, *residues = NULL;
-    t_filenm        fnm[] = {
+    gmx_output_env_t *oenv;
+    t_topology       *top  = NULL;
+    int               ePBC = -1;
+    rvec             *x;
+    matrix            box;
+    gmx_bool          bTop = FALSE;
+
+    int               i, nres = 0;
+    const char       *trxfnm, *tpsfnm, *ndxfnm, *distfnm, *numfnm, *atmfnm, *oxfnm, *resfnm;
+    char            **grpname;
+    int              *gnx;
+    atom_id         **index, *residues = NULL;
+    t_filenm          fnm[] = {
         { efTRX, "-f",  NULL,      ffREAD },
         { efTPS,  NULL, NULL,      ffOPTRD },
         { efNDX,  NULL, NULL,      ffOPTRD },
index 4554e216d19b941e38a2830e2025a77b91985e0b..b86aba3ca7fae3027de60ee247c382e4fa3f9d61 100644 (file)
@@ -267,7 +267,7 @@ int gmx_mk_angndx(int argc, char *argv[])
           "Ignore angles with atoms with mass < 1.5 and magnitude of their charge less than this value" }
     };
 
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     FILE              *out;
     t_topology        *top;
     int                i, j, ntype;
index 0c6785013705116bd5f3f914feb73796afaaef54..b58b326276b55095742e236a490c1e61513f9d96 100644 (file)
@@ -73,7 +73,7 @@ static real dointerp(int n, rvec x1[], rvec x2[], rvec xx[],
 
 int gmx_morph(int argc, char *argv[])
 {
-    const char      *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] does a linear interpolation of conformations in order to",
         "create intermediates. Of course these are completely unphysical, but",
         "that you may try to justify yourself. Output is in the form of a ",
@@ -89,7 +89,7 @@ int gmx_morph(int argc, char *argv[])
         "if explicitly selected ([TT]-or[tt] option). In that case, an index file may be",
         "read to select the group from which the RMS is computed."
     };
-    t_filenm         fnm[] = {
+    t_filenm          fnm[] = {
         { efSTX, "-f1", "conf1",  ffREAD },
         { efSTX, "-f2", "conf2",  ffREAD },
         { efTRX, "-o",  "interm", ffWRITE },
@@ -97,11 +97,11 @@ int gmx_morph(int argc, char *argv[])
         { efNDX, "-n",  "index",  ffOPTRD }
     };
 #define NFILE asize(fnm)
-    static  int      ninterm = 11;
-    static  real     first   = 0.0;
-    static  real     last    = 1.0;
-    static  gmx_bool bFit    = TRUE;
-    t_pargs          pa []   = {
+    static  int       ninterm = 11;
+    static  real      first   = 0.0;
+    static  real      last    = 1.0;
+    static  gmx_bool  bFit    = TRUE;
+    t_pargs           pa []   = {
         { "-ninterm", FALSE, etINT,  {&ninterm},
           "Number of intermediates" },
         { "-first",   FALSE, etREAL, {&first},
@@ -111,17 +111,17 @@ int gmx_morph(int argc, char *argv[])
         { "-fit",     FALSE, etBOOL, {&bFit},
           "Do a least squares fit of the second to the first structure before interpolating" }
     };
-    const char      *leg[] = { "Ref = 1\\Sst\\N conf", "Ref = 2\\Snd\\N conf" };
-    FILE            *fp    = NULL;
-    int              i, isize, is_lsq, nat1, nat2;
-    t_trxstatus     *status;
-    atom_id         *index, *index_lsq, *index_all, *dummy;
-    rvec            *x1, *x2, *xx;
-    matrix           box;
-    real             rms1, rms2, fac, *mass;
-    char            *grpname;
-    gmx_bool         bRMS;
-    output_env_t     oenv;
+    const char       *leg[] = { "Ref = 1\\Sst\\N conf", "Ref = 2\\Snd\\N conf" };
+    FILE             *fp    = NULL;
+    int               i, isize, is_lsq, nat1, nat2;
+    t_trxstatus      *status;
+    atom_id          *index, *index_lsq, *index_all, *dummy;
+    rvec             *x1, *x2, *xx;
+    matrix            box;
+    real              rms1, rms2, fac, *mass;
+    char             *grpname;
+    gmx_bool          bRMS;
+    gmx_output_env_t *oenv;
 
     if (!parse_common_args(&argc, argv, PCA_CAN_VIEW,
                            NFILE, fnm, asize(pa), pa, asize(desc), desc,
index b3c53e5d1204e051cedf65348ae334e25a028885..361c52b113aa13cab6ff66d8b1e06cf8f1e73ac8 100644 (file)
@@ -176,7 +176,7 @@ static void corr_print(t_corr *curr, gmx_bool bTen, const char *fn, const char *
                        const char *yaxis,
                        real msdtime, real beginfit, real endfit,
                        real *DD, real *SigmaD, char *grpname[],
-                       const output_env_t oenv)
+                       const gmx_output_env_t *oenv)
 {
     FILE *out;
     int   i, j;
@@ -546,7 +546,7 @@ static real calc1_mol(t_corr *curr, int nx, atom_id gmx_unused index[], int nx0,
 
 void printmol(t_corr *curr, const char *fn,
               const char *fn_pdb, int *molindex, t_topology *top,
-              rvec *x, int ePBC, matrix box, const output_env_t oenv)
+              rvec *x, int ePBC, matrix box, const gmx_output_env_t *oenv)
 {
 #define NDIST 100
     FILE       *out;
@@ -644,7 +644,7 @@ int corr_loop(t_corr *curr, const char *fn, t_topology *top, int ePBC,
               gmx_bool bMol, int gnx[], atom_id *index[],
               t_calc_func *calc1, gmx_bool bTen, int *gnx_com, atom_id *index_com[],
               real dt, real t_pdb, rvec **x_pdb, matrix box_pdb,
-              const output_env_t oenv)
+              const gmx_output_env_t *oenv)
 {
     rvec            *x[2];  /* the coordinates to read */
     rvec            *xa[2]; /* the coordinates to calculate displacements for */
@@ -877,7 +877,7 @@ void do_corr(const char *trx_file, const char *ndx_file, const char *msd_file,
              int nrgrp, t_topology *top, int ePBC,
              gmx_bool bTen, gmx_bool bMW, gmx_bool bRmCOMM,
              int type, real dim_factor, int axis,
-             real dt, real beginfit, real endfit, const output_env_t oenv)
+             real dt, real beginfit, real endfit, const gmx_output_env_t *oenv)
 {
     t_corr        *msd;
     int           *gnx;   /* the selected groups' sizes */
@@ -1113,15 +1113,15 @@ int gmx_msd(int argc, char *argv[])
     };
 #define NFILE asize(fnm)
 
-    t_topology      top;
-    int             ePBC;
-    matrix          box;
-    const char     *trx_file, *tps_file, *ndx_file, *msd_file, *mol_file, *pdb_file;
-    rvec           *xdum;
-    gmx_bool        bTop;
-    int             axis, type;
-    real            dim_factor;
-    output_env_t    oenv;
+    t_topology        top;
+    int               ePBC;
+    matrix            box;
+    const char       *trx_file, *tps_file, *ndx_file, *msd_file, *mol_file, *pdb_file;
+    rvec             *xdum;
+    gmx_bool          bTop;
+    int               axis, type;
+    real              dim_factor;
+    gmx_output_env_t *oenv;
 
     if (!parse_common_args(&argc, argv,
                            PCA_CAN_VIEW | PCA_CAN_BEGIN | PCA_CAN_END | PCA_TIME_UNIT,
index f3deec3f41ccf773d67758740de79793e61514d1..aa9ad7b16943c0992cce7b4e30e5ac8f2619b4a0 100644 (file)
@@ -333,7 +333,7 @@ int gmx_nmeig(int argc, char *argv[])
     real                   factor_omega_to_wavenumber;
     real                  *spectrum = NULL;
     real                   wfac;
-    output_env_t           oenv;
+    gmx_output_env_t      *oenv;
     const char            *qcleg[] = {
         "Heat Capacity cV (J/mol K)",
         "Enthalpy H (kJ/mol)"
index ae521bdfa737e2b13775208a82a6bc7be5678f5a..56052719913a9ab3f0cc60a77bdc41f325417fc4 100644 (file)
@@ -102,7 +102,7 @@ int gmx_nmens(int argc, char *argv[])
     int                 nout, *iout, noutvec, *outvec;
     atom_id            *index;
     real                rfac, rhalf, jr;
-    output_env_t        oenv;
+    gmx_output_env_t   *oenv;
     gmx_rng_t           rng;
     int                 jran;
     const unsigned long im = 0xffff;
index 9013631e5b482d7907f356106aad15991e754121..7e3e9d64f6337ec277397acf5501b7df09f7fb2f 100644 (file)
@@ -120,7 +120,7 @@ int gmx_nmtraj(int argc, char *argv[])
     real             *phases;
     const char       *p;
     char             *pe;
-    output_env_t      oenv;
+    gmx_output_env_t *oenv;
 
     t_filenm          fnm[] =
     {
index 85124f81a0ad2cf4d89b9d052147e86dce837e4e..3b6f8e5016e48dea84f8a8b68cd2c93f28e4d3bf 100644 (file)
@@ -254,7 +254,7 @@ static void calc_tetra_order_parm(const char *fnNDX, const char *fnTPS,
                                   const char *skfn,
                                   int nslice, int slice_dim,
                                   const char *sgslfn, const char *skslfn,
-                                  const output_env_t oenv)
+                                  const gmx_output_env_t *oenv)
 {
     FILE        *fpsg = NULL, *fpsk = NULL;
     t_topology   top;
@@ -375,7 +375,7 @@ void calc_order(const char *fn, atom_id *index, atom_id *a, rvec **order,
                 gmx_bool bUnsat, t_topology *top, int ePBC, int ngrps, int axis,
                 gmx_bool permolecule, gmx_bool radial, gmx_bool distcalc, const char *radfn,
                 real ***distvals,
-                const output_env_t oenv)
+                const gmx_output_env_t *oenv)
 {
     /* if permolecule = TRUE, order parameters will be calculed per molecule
      * and stored in slOrder with #slices = # molecules */
@@ -754,7 +754,7 @@ void calc_order(const char *fn, atom_id *index, atom_id *a, rvec **order,
 
 void order_plot(rvec order[], real *slOrder[], const char *afile, const char *bfile,
                 const char *cfile, int ngrps, int nslices, real slWidth, gmx_bool bSzonly,
-                gmx_bool permolecule, real **distvals, const output_env_t oenv)
+                gmx_bool permolecule, real **distvals, const gmx_output_env_t *oenv)
 {
     FILE       *ord, *slOrd;      /* xvgr files with order parameters  */
     int         atom, slice;      /* atom corresponding to order para.*/
@@ -833,7 +833,7 @@ void order_plot(rvec order[], real *slOrder[], const char *afile, const char *bf
     xvgrclose(slOrd);
 }
 
-void write_bfactors(t_filenm  *fnm, int nfile, atom_id *index, atom_id *a, int nslices, int ngrps, real **order, t_topology *top, real **distvals, output_env_t oenv)
+void write_bfactors(t_filenm  *fnm, int nfile, atom_id *index, atom_id *a, int nslices, int ngrps, real **order, t_topology *top, real **distvals, gmx_output_env_t *oenv)
 {
     /*function to write order parameters as B factors in PDB file using
           first frame of trajectory*/
@@ -947,12 +947,12 @@ int gmx_order(int argc, char *argv[])
     int                ngrps,                         /* nr. of groups              */
                        i,
                        axis = 0;                      /* normal axis                */
-    t_topology   *top;                                /* topology         */
-    int           ePBC;
-    atom_id      *index,                              /* indices for a              */
+    t_topology       *top;                            /* topology         */
+    int               ePBC;
+    atom_id          *index,                          /* indices for a              */
     *a;                                               /* atom numbers in each group */
-    t_blocka     *block;                              /* data from index file       */
-    t_filenm      fnm[] = {                           /* files for g_order    */
+    t_blocka         *block;                          /* data from index file       */
+    t_filenm          fnm[] = {                       /* files for g_order    */
         { efTRX, "-f", NULL,  ffREAD },               /* trajectory file              */
         { efNDX, "-n", NULL,  ffREAD },               /* index file           */
         { efNDX, "-nr", NULL,  ffREAD },              /* index for radial axis calculation       */
@@ -966,11 +966,11 @@ int gmx_order(int argc, char *argv[])
         { efXVG, "-Sgsl", "sg-ang-slice", ffOPTWR },  /* xvgr output file           */
         { efXVG, "-Sksl", "sk-dist-slice", ffOPTWR }, /* xvgr output file           */
     };
-    gmx_bool      bSliced = FALSE;                    /* True if box is sliced      */
+    gmx_bool          bSliced = FALSE;                /* True if box is sliced      */
 #define NFILE asize(fnm)
-    real        **distvals = NULL;
-    const char   *sgfnm, *skfnm, *ndxfnm, *tpsfnm, *trxfnm;
-    output_env_t  oenv;
+    real            **distvals = NULL;
+    const char       *sgfnm, *skfnm, *ndxfnm, *tpsfnm, *trxfnm;
+    gmx_output_env_t *oenv;
 
     if (!parse_common_args(&argc, argv, PCA_CAN_VIEW | PCA_CAN_TIME,
                            NFILE, fnm, asize(pa), pa, asize(desc), desc, 0, NULL, &oenv))
index c3270d0079471b8d3a3f878f3724efe75cfb422e..87a65fdb991b403f6245650703e3f572e8112ece 100644 (file)
@@ -1105,15 +1105,15 @@ int gmx_pme_error(int argc, char *argv[])
     int             seed     = 0;
 
 
-    static t_filenm fnm[] = {
+    static t_filenm   fnm[] = {
         { efTPR, "-s",     NULL,    ffREAD },
         { efOUT, "-o",    "error",  ffWRITE },
         { efTPR, "-so",   "tuned",  ffOPTWR }
     };
 
-    output_env_t    oenv = NULL;
+    gmx_output_env_t *oenv = NULL;
 
-    t_pargs         pa[] = {
+    t_pargs           pa[] = {
         { "-beta",     FALSE, etREAL, {&user_beta},
           "If positive, overwrite ewald_beta from [REF].tpr[ref] file with this value" },
         { "-tune",     FALSE, etBOOL, {&bTUNE},
index 3931ac17143062e984a242ae22f527699a9c48b2..a9d92150f44bea2b7d9c90fe30b4fc9c3bd16cbb 100644 (file)
@@ -151,32 +151,32 @@ int gmx_polystat(int argc, char *argv[])
     };
 #define NFILE asize(fnm)
 
-    t_topology  *top;
-    output_env_t oenv;
-    int          ePBC;
-    int          isize, *index, nmol, *molind, mol, nat_min = 0, nat_max = 0;
-    char        *grpname;
-    t_trxstatus *status;
-    real         t;
-    rvec        *x, *bond = NULL;
-    matrix       box;
-    int          natoms, i, j, frame, ind0, ind1, a, d, d2, ord[DIM] = {0};
-    dvec         cm, sum_eig = {0, 0, 0};
-    double     **gyr, **gyr_all, eig[DIM], **eigv;
-    double       sum_eed2, sum_eed2_tot, sum_gyro, sum_gyro_tot, sum_pers_tot;
-    int         *ninp    = NULL;
-    double      *sum_inp = NULL, pers;
-    double      *intd, ymax, ymin;
-    double       mmol, m;
-    char         title[STRLEN];
-    FILE        *out, *outv, *outp, *outi;
-    const char  *leg[8] = {
+    t_topology       *top;
+    gmx_output_env_t *oenv;
+    int               ePBC;
+    int               isize, *index, nmol, *molind, mol, nat_min = 0, nat_max = 0;
+    char             *grpname;
+    t_trxstatus      *status;
+    real              t;
+    rvec             *x, *bond = NULL;
+    matrix            box;
+    int               natoms, i, j, frame, ind0, ind1, a, d, d2, ord[DIM] = {0};
+    dvec              cm, sum_eig = {0, 0, 0};
+    double          **gyr, **gyr_all, eig[DIM], **eigv;
+    double            sum_eed2, sum_eed2_tot, sum_gyro, sum_gyro_tot, sum_pers_tot;
+    int              *ninp    = NULL;
+    double           *sum_inp = NULL, pers;
+    double           *intd, ymax, ymin;
+    double            mmol, m;
+    char              title[STRLEN];
+    FILE             *out, *outv, *outp, *outi;
+    const char       *leg[8] = {
         "end to end", "<R\\sg\\N>",
         "<R\\sg\\N> eig1", "<R\\sg\\N> eig2", "<R\\sg\\N> eig3",
         "<R\\sg\\N eig1>", "<R\\sg\\N eig2>", "<R\\sg\\N eig3>"
     };
-    char       **legp, buf[STRLEN];
-    gmx_rmpbc_t  gpbc = NULL;
+    char            **legp, buf[STRLEN];
+    gmx_rmpbc_t       gpbc = NULL;
 
     if (!parse_common_args(&argc, argv,
                            PCA_CAN_VIEW | PCA_CAN_TIME | PCA_TIME_UNIT,
index 513dd6a1d3a07067fbc0773c4bd9b00c21a93921..6b30bc7047c601048e408012ea576bd19bd1ed33 100644 (file)
@@ -104,7 +104,7 @@ void calc_potential(const char *fn, atom_id **index, int gnx[],
                     t_topology *top, int ePBC,
                     int axis, int nr_grps, double *slWidth,
                     double fudge_z, gmx_bool bSpherical, gmx_bool bCorrect,
-                    const output_env_t oenv)
+                    const gmx_output_env_t *oenv)
 {
     rvec        *x0;     /* coordinates without pbc */
     matrix       box;    /* box (3x3) */
@@ -361,7 +361,7 @@ void calc_potential(const char *fn, atom_id **index, int gnx[],
 void plot_potential(double *potential[], double *charge[], double *field[],
                     const char *afile, const char *bfile, const char *cfile,
                     int nslices, int nr_grps, const char *grpname[], double slWidth,
-                    const output_env_t oenv)
+                    const gmx_output_env_t *oenv)
 {
     FILE       *pot,     /* xvgr file with potential */
     *cha,                /* xvgr file with charges   */
@@ -414,7 +414,7 @@ int gmx_potential(int argc, char *argv[])
         "spherical slices and twice integrating them. epsilon_r is taken as 1,",
         "but 2 is more appropriate in many cases."
     };
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     static int         axis       = 2;       /* normal to memb. default z  */
     static const char *axtitle    = "Z";
     static int         nslices    = 10;      /* nr of slices defined       */
index dfda859efe18569addf4a7fd1728213cd5f0d29b..d2e596b3836780667eca85e67689e48ea378fa96 100644 (file)
@@ -73,7 +73,7 @@ calc_principal_axes(t_topology *   top,
 
 int gmx_principal(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] calculates the three principal axes of inertia for a group",
         "of atoms. NOTE: Old versions of GROMACS wrote the output data in a",
         "strange transposed way. As of GROMACS 5.0, the output file paxis1.dat",
@@ -81,32 +81,32 @@ int gmx_principal(int argc, char *argv[])
         "each frame, and similarly for the middle and minor axes in paxis2.dat",
         "and paxis3.dat."
     };
-    static gmx_bool foo = FALSE;
+    static gmx_bool   foo = FALSE;
 
-    t_pargs         pa[] = {
+    t_pargs           pa[] = {
         { "-foo",      FALSE, etBOOL, {&foo}, "Dummy option to avoid empty array" }
     };
-    t_trxstatus    *status;
-    t_topology      top;
-    int             ePBC;
-    real            t;
-    rvec      *     x;
-
-    int             natoms;
-    char           *grpname;
-    int             i, gnx;
-    atom_id        *index;
-    rvec            moi;
-    FILE      *     axis1;
-    FILE      *     axis2;
-    FILE      *     axis3;
-    FILE      *     fmoi;
-    matrix          axes, box;
-    output_env_t    oenv;
-    gmx_rmpbc_t     gpbc = NULL;
-    char **         legend;
-
-    t_filenm        fnm[] = {
+    t_trxstatus      *status;
+    t_topology        top;
+    int               ePBC;
+    real              t;
+    rvec        *     x;
+
+    int               natoms;
+    char             *grpname;
+    int               i, gnx;
+    atom_id          *index;
+    rvec              moi;
+    FILE        *     axis1;
+    FILE        *     axis2;
+    FILE        *     axis3;
+    FILE        *     fmoi;
+    matrix            axes, box;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
+    char   **         legend;
+
+    t_filenm          fnm[] = {
         { efTRX, "-f",   NULL,       ffREAD },
         { efTPS, NULL,   NULL,       ffREAD },
         { efNDX, NULL,   NULL,       ffOPTRD },
index 924ecb05f63f1015f793c2bdb588a3f6abcbe550..c048930e23f1341dad061493bddab7f6009bdea3 100644 (file)
@@ -67,18 +67,18 @@ static void plot_rama(FILE *out, t_xrama *xr)
 
 int gmx_rama(int argc, char *argv[])
 {
-    const char  *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] selects the [GRK]phi[grk]/[GRK]psi[grk] dihedral combinations from your topology file",
         "and computes these as a function of time.",
         "Using simple Unix tools such as [IT]grep[it] you can select out",
         "specific residues."
     };
 
-    FILE        *out;
-    t_xrama     *xr;
-    int          j;
-    output_env_t oenv;
-    t_filenm     fnm[] = {
+    FILE             *out;
+    t_xrama          *xr;
+    int               j;
+    gmx_output_env_t *oenv;
+    t_filenm          fnm[] = {
         { efTRX, "-f", NULL,  ffREAD },
         { efTPR, NULL, NULL,  ffREAD },
         { efXVG, NULL, "rama", ffWRITE }
index 5b6d7c040e7de500325de9312bd534432d9e4d66..9b4f5a309cc4d873c2525a1272e6be276d129a1b 100644 (file)
@@ -240,21 +240,21 @@ int gmx_rms(int argc, char *argv[])
     real            rlstot = 0, **rls, **rlsm = NULL, *time, *time2, *rlsnorm = NULL,
     **rmsd_mat             = NULL, **bond_mat = NULL, *axis, *axis2, *del_xaxis,
     *del_yaxis, rmsd_max, rmsd_min, rmsd_avg, bond_max, bond_min, ang;
-    real       **rmsdav_mat = NULL, av_tot, weight, weight_tot;
-    real       **delta      = NULL, delta_max, delta_scalex = 0, delta_scaley = 0,
+    real            **rmsdav_mat = NULL, av_tot, weight, weight_tot;
+    real            **delta      = NULL, delta_max, delta_scalex = 0, delta_scaley = 0,
     *delta_tot;
-    int          delta_xsize = 0, del_lev = 100, mx, my, abs_my;
-    gmx_bool     bA1, bA2, bPrev, bTop, *bInMat = NULL;
-    int          ifit, *irms, ibond = 0, *ind_bond1 = NULL, *ind_bond2 = NULL, n_ind_m =
+    int               delta_xsize = 0, del_lev = 100, mx, my, abs_my;
+    gmx_bool          bA1, bA2, bPrev, bTop, *bInMat = NULL;
+    int               ifit, *irms, ibond = 0, *ind_bond1 = NULL, *ind_bond2 = NULL, n_ind_m =
         0;
-    atom_id     *ind_fit, **ind_rms, *ind_m = NULL, *rev_ind_m = NULL, *ind_rms_m =
+    atom_id          *ind_fit, **ind_rms, *ind_m = NULL, *rev_ind_m = NULL, *ind_rms_m =
         NULL;
-    char        *gn_fit, **gn_rms;
-    t_rgb        rlo, rhi;
-    output_env_t oenv;
-    gmx_rmpbc_t  gpbc = NULL;
+    char             *gn_fit, **gn_rms;
+    t_rgb             rlo, rhi;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
 
-    t_filenm     fnm[] =
+    t_filenm          fnm[] =
     {
         { efTPS, NULL, NULL, ffREAD },
         { efTRX, "-f", NULL, ffREAD },
index 65d841dc262e074100839e7f2f8ced78412db276..ccbdc41f9ac71766819615deae8af4631e9ec6af 100644 (file)
@@ -629,7 +629,7 @@ real rms_diff(int natom, real **d, real **d_r)
 
 int gmx_rmsdist(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] computes the root mean square deviation of atom distances,",
         "which has the advantage that no fit is needed like in standard RMS",
         "deviation as computed by [gmx-rms].",
@@ -653,36 +653,36 @@ int gmx_rmsdist(int argc, char *argv[])
 
     };
 
-    int             i, teller;
-    real            t;
-
-    t_topology      top;
-    int             ePBC;
-    t_atoms        *atoms;
-    matrix          box;
-    rvec           *x;
-    FILE           *fp;
-
-    t_trxstatus    *status;
-    int             isize, gnr = 0;
-    atom_id        *index, *noe_index;
-    char           *grpname;
-    real          **d_r, **d, **dtot, **dtot2, **mean, **rms, **rmsc, *resnr;
-    real          **dtot1_3 = NULL, **dtot1_6 = NULL;
-    real            rmsnow, meanmax, rmsmax, rmscmax;
-    real            max1_3, max1_6;
-    t_noe_gr       *noe_gr = NULL;
-    t_noe         **noe    = NULL;
-    t_rgb           rlo, rhi;
-    gmx_bool        bRMS, bScale, bMean, bNOE, bNMR3, bNMR6, bNMR;
-
-    static int      nlevels  = 40;
-    static real     scalemax = -1.0;
-    static gmx_bool bSumH    = TRUE;
-    static gmx_bool bPBC     = TRUE;
-    output_env_t    oenv;
-
-    t_pargs         pa[] = {
+    int               i, teller;
+    real              t;
+
+    t_topology        top;
+    int               ePBC;
+    t_atoms          *atoms;
+    matrix            box;
+    rvec             *x;
+    FILE             *fp;
+
+    t_trxstatus      *status;
+    int               isize, gnr = 0;
+    atom_id          *index, *noe_index;
+    char             *grpname;
+    real            **d_r, **d, **dtot, **dtot2, **mean, **rms, **rmsc, *resnr;
+    real            **dtot1_3 = NULL, **dtot1_6 = NULL;
+    real              rmsnow, meanmax, rmsmax, rmscmax;
+    real              max1_3, max1_6;
+    t_noe_gr         *noe_gr = NULL;
+    t_noe           **noe    = NULL;
+    t_rgb             rlo, rhi;
+    gmx_bool          bRMS, bScale, bMean, bNOE, bNMR3, bNMR6, bNMR;
+
+    static int        nlevels  = 40;
+    static real       scalemax = -1.0;
+    static gmx_bool   bSumH    = TRUE;
+    static gmx_bool   bPBC     = TRUE;
+    gmx_output_env_t *oenv;
+
+    t_pargs           pa[] = {
         { "-nlevels",   FALSE, etINT,  {&nlevels},
           "Discretize RMS in this number of levels" },
         { "-max",   FALSE, etREAL, {&scalemax},
@@ -692,7 +692,7 @@ int gmx_rmsdist(int argc, char *argv[])
         { "-pbc",   FALSE, etBOOL, {&bPBC},
           "Use periodic boundary conditions when computing distances" }
     };
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efTRX, "-f",   NULL,       ffREAD },
         { efTPS, NULL,   NULL,       ffREAD },
         { efNDX, NULL,   NULL,       ffOPTRD },
index 6d7aa0f560f03dcf1221e160a51333850a110c8d..a9d0f9cf78393fe61a035ad5f52872738ac32ecf 100644 (file)
@@ -86,7 +86,7 @@ static real find_pdb_bfac(t_atoms *atoms, t_resinfo *ri, char *atomnm)
 }
 
 void correlate_aniso(const char *fn, t_atoms *ref, t_atoms *calc,
-                     const output_env_t oenv)
+                     const gmx_output_env_t *oenv)
 {
     FILE *fp;
     int   i, j;
@@ -187,7 +187,7 @@ void print_dir(FILE *fp, real *Uaver)
 
 int gmx_rmsf(int argc, char *argv[])
 {
-    const char      *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] computes the root mean square fluctuation (RMSF, i.e. standard ",
         "deviation) of atomic positions in the trajectory (supplied with [TT]-f[tt])",
         "after (optionally) fitting to a reference frame (supplied with [TT]-s[tt]).[PAR]",
@@ -212,8 +212,8 @@ int gmx_rmsf(int argc, char *argv[])
         "This shows the directions in which the atoms fluctuate the most and",
         "the least."
     };
-    static gmx_bool  bRes    = FALSE, bAniso = FALSE, bFit = TRUE;
-    t_pargs          pargs[] = {
+    static gmx_bool   bRes    = FALSE, bAniso = FALSE, bFit = TRUE;
+    t_pargs           pargs[] = {
         { "-res", FALSE, etBOOL, {&bRes},
           "Calculate averages for each residue" },
         { "-aniso", FALSE, etBOOL, {&bAniso},
@@ -221,43 +221,43 @@ int gmx_rmsf(int argc, char *argv[])
         { "-fit", FALSE, etBOOL, {&bFit},
           "Do a least squares superposition before computing RMSF. Without this you must make sure that the reference structure and the trajectory match." }
     };
-    int              natom;
-    int              i, m, teller = 0;
-    real             t, *w_rls;
-
-    t_topology       top;
-    int              ePBC;
-    t_atoms         *pdbatoms, *refatoms;
-
-    matrix           box, pdbbox;
-    rvec            *x, *pdbx, *xref;
-    t_trxstatus     *status;
-    const char      *label;
-
-    FILE            *fp;          /* the graphics file */
-    const char      *devfn, *dirfn;
-    int              resind;
-
-    gmx_bool         bReadPDB;
-    atom_id         *index;
-    int              isize;
-    char            *grpnames;
-
-    real             bfac, pdb_bfac, *Uaver;
-    double         **U, *xav;
-    atom_id          aid;
-    rvec            *rmsd_x = NULL;
-    double          *rmsf, invcount, totmass;
-    int              d;
-    real             count = 0;
-    rvec             xcm;
-    gmx_rmpbc_t      gpbc = NULL;
-
-    output_env_t     oenv;
-
-    const char      *leg[2] = { "MD", "X-Ray" };
-
-    t_filenm         fnm[] = {
+    int               natom;
+    int               i, m, teller = 0;
+    real              t, *w_rls;
+
+    t_topology        top;
+    int               ePBC;
+    t_atoms          *pdbatoms, *refatoms;
+
+    matrix            box, pdbbox;
+    rvec             *x, *pdbx, *xref;
+    t_trxstatus      *status;
+    const char       *label;
+
+    FILE             *fp;         /* the graphics file */
+    const char       *devfn, *dirfn;
+    int               resind;
+
+    gmx_bool          bReadPDB;
+    atom_id          *index;
+    int               isize;
+    char             *grpnames;
+
+    real              bfac, pdb_bfac, *Uaver;
+    double          **U, *xav;
+    atom_id           aid;
+    rvec             *rmsd_x = NULL;
+    double           *rmsf, invcount, totmass;
+    int               d;
+    real              count = 0;
+    rvec              xcm;
+    gmx_rmpbc_t       gpbc = NULL;
+
+    gmx_output_env_t *oenv;
+
+    const char       *leg[2] = { "MD", "X-Ray" };
+
+    t_filenm          fnm[] = {
         { efTRX, "-f",  NULL,     ffREAD  },
         { efTPS, NULL,  NULL,     ffREAD  },
         { efNDX, NULL,  NULL,     ffOPTRD },
index 90528f1dcf9429fb23293322f12980206f89cc4c..0628136e4259e45c6abfc87f3296b184646c0b3f 100644 (file)
@@ -55,7 +55,7 @@
 
 int gmx_rotacf(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] calculates the rotational correlation function",
         "for molecules. Atom triplets (i,j,k) must be given in the index",
         "file, defining two vectors ij and jk. The rotational ACF",
@@ -74,40 +74,40 @@ int gmx_rotacf(int argc, char *argv[])
         "file. The correlation function will be fitted from 2.5 ps until 20.0 ps",
         "to a two-parameter exponential."
     };
-    static gmx_bool bVec    = FALSE, bAver = TRUE;
+    static gmx_bool   bVec    = FALSE, bAver = TRUE;
 
-    t_pargs         pa[] = {
+    t_pargs           pa[] = {
         { "-d",   FALSE, etBOOL, {&bVec},
           "Use index doublets (vectors) for correlation function instead of triplets (planes)" },
         { "-aver", FALSE, etBOOL, {&bAver},
           "Average over molecules" }
     };
 
-    t_trxstatus    *status;
-    int             isize;
-    atom_id        *index;
-    char           *grpname;
-    rvec           *x, *x_s;
-    matrix          box;
-    real          **c1;
-    rvec            xij, xjk, n;
-    int             i, m, teller, n_alloc, natoms, nvec, ai, aj, ak;
-    unsigned long   mode;
-    real            t, t0, t1, dt;
-    gmx_rmpbc_t     gpbc = NULL;
-    t_topology     *top;
-    int             ePBC;
-    t_filenm        fnm[] = {
+    t_trxstatus      *status;
+    int               isize;
+    atom_id          *index;
+    char             *grpname;
+    rvec             *x, *x_s;
+    matrix            box;
+    real            **c1;
+    rvec              xij, xjk, n;
+    int               i, m, teller, n_alloc, natoms, nvec, ai, aj, ak;
+    unsigned long     mode;
+    real              t, t0, t1, dt;
+    gmx_rmpbc_t       gpbc = NULL;
+    t_topology       *top;
+    int               ePBC;
+    t_filenm          fnm[] = {
         { efTRX, "-f", NULL,  ffREAD  },
         { efTPR, NULL, NULL,  ffREAD },
         { efNDX, NULL, NULL,  ffREAD  },
         { efXVG, "-o", "rotacf",  ffWRITE }
     };
 #define NFILE asize(fnm)
-    int             npargs;
-    t_pargs        *ppa;
+    int               npargs;
+    t_pargs          *ppa;
 
-    output_env_t    oenv;
+    gmx_output_env_t *oenv;
 
     npargs = asize(pa);
     ppa    = add_acf_pargs(&npargs, pa);
index 7d0d62370d1b2ca930b6efbf2dcf7c71219919e3..174f82ec9ae67ae2e17b3ac532e66099b593a4aa 100644 (file)
@@ -54,7 +54,7 @@
 #include "gromacs/utility/gmxassert.h"
 #include "gromacs/utility/smalloc.h"
 
-static void get_refx(output_env_t oenv, const char *trxfn, int nfitdim, int skip,
+static void get_refx(gmx_output_env_t *oenv, const char *trxfn, int nfitdim, int skip,
                      int gnx, int *index,
                      gmx_bool bMW, t_topology *top, int ePBC, rvec *x_ref)
 {
@@ -175,7 +175,7 @@ static void get_refx(output_env_t oenv, const char *trxfn, int nfitdim, int skip
 
 int gmx_rotmat(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] plots the rotation matrix required for least squares fitting",
         "a conformation onto the reference conformation provided with",
         "[TT]-s[tt]. Translation is removed before fitting.",
@@ -201,11 +201,11 @@ int gmx_rotmat(int argc, char *argv[])
         "Option [TT]-fitxy[tt] fits in the [IT]x-y[it] plane before determining",
         "the rotation matrix."
     };
-    const char     *reffit[] =
+    const char       *reffit[] =
     { NULL, "none", "xyz", "xy", NULL };
-    static int      skip   = 1;
-    static gmx_bool bFitXY = FALSE, bMW = TRUE;
-    t_pargs         pa[]   = {
+    static int        skip   = 1;
+    static gmx_bool   bFitXY = FALSE, bMW = TRUE;
+    t_pargs           pa[]   = {
         { "-ref", FALSE, etENUM, {reffit},
           "Determine the optimal reference structure" },
         { "-skip", FALSE, etINT, {&skip},
@@ -215,23 +215,23 @@ int gmx_rotmat(int argc, char *argv[])
         { "-mw", FALSE, etBOOL, {&bMW},
           "Use mass weighted fitting" }
     };
-    FILE           *out;
-    t_trxstatus    *status;
-    t_topology      top;
-    int             ePBC;
-    rvec           *x_ref, *x;
-    matrix          box, R;
-    real            t;
-    int             natoms, i;
-    char           *grpname;
-    int             gnx;
-    gmx_rmpbc_t     gpbc = NULL;
-    atom_id        *index;
-    output_env_t    oenv;
-    real           *w_rls;
-    const char     *leg[]  = { "xx", "xy", "xz", "yx", "yy", "yz", "zx", "zy", "zz" };
+    FILE             *out;
+    t_trxstatus      *status;
+    t_topology        top;
+    int               ePBC;
+    rvec             *x_ref, *x;
+    matrix            box, R;
+    real              t;
+    int               natoms, i;
+    char             *grpname;
+    int               gnx;
+    gmx_rmpbc_t       gpbc = NULL;
+    atom_id          *index;
+    gmx_output_env_t *oenv;
+    real             *w_rls;
+    const char       *leg[]  = { "xx", "xy", "xz", "yx", "yy", "yz", "zx", "zy", "zz" };
 #define NLEG asize(leg)
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efTRX, "-f",   NULL,       ffREAD },
         { efTPS, NULL,   NULL,       ffREAD },
         { efNDX, NULL,   NULL,       ffOPTRD },
index 51a9675f861d8a2b56092afc8e190544aaa3f448..2557b71274aa18d8b2a207fe633bf050d3d2f7ef 100644 (file)
@@ -179,7 +179,7 @@ int gmx_saltbr(int argc, char *argv[])
     t_pbc              pbc;
     rvec              *x;
     matrix             box;
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
 
     if (!parse_common_args(&argc, argv, PCA_CAN_TIME,
                            NFILE, fnm, asize(pa), pa, asize(desc), desc, 0, NULL, &oenv))
index 4c7d30c996f85e74b574e153bb074b5734c6f891..d9b8324f341d14be9c986713aaba25e4f92f0271 100644 (file)
@@ -139,7 +139,7 @@ int gmx_sans(int argc, char *argv[])
     t_filenm                             *fnmdup         = NULL;
     gmx_radial_distribution_histogram_t  *prframecurrent = NULL, *pr = NULL;
     gmx_static_structurefactor_t         *sqframecurrent = NULL, *sq = NULL;
-    output_env_t                          oenv;
+    gmx_output_env_t                     *oenv;
 
 #define NFILE asize(fnm)
 
index 9757e01982d5e276948007d1eedafadf0f9c1929..aa7285f2a2b90b7882a0ea859b8c9e274eb33246 100644 (file)
 
 int gmx_saxs(int argc, char *argv[])
 {
-    const char  *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] calculates SAXS structure factors for given index",
         "groups based on Cromer's method.",
         "Both topology and trajectory files are required."
     };
 
-    static real  start_q = 0.0, end_q = 60.0, energy = 12.0;
-    static int   ngroups = 1;
+    static real       start_q = 0.0, end_q = 60.0, energy = 12.0;
+    static int        ngroups = 1;
 
-    t_pargs      pa[] = {
+    t_pargs           pa[] = {
         { "-ng",       FALSE, etINT, {&ngroups},
           "Number of groups to compute SAXS" },
         {"-startq", FALSE, etREAL, {&start_q},
@@ -68,10 +68,10 @@ int gmx_saxs(int argc, char *argv[])
          "Energy of the incoming X-ray (keV) "}
     };
 #define NPA asize(pa)
-    const char  *fnTPS, *fnTRX, *fnNDX, *fnDAT = NULL;
-    output_env_t oenv;
+    const char       *fnTPS, *fnTRX, *fnNDX, *fnDAT = NULL;
+    gmx_output_env_t *oenv;
 
-    t_filenm     fnm[] = {
+    t_filenm          fnm[] = {
         { efTRX, "-f",  NULL,      ffREAD },
         { efTPS, NULL,  NULL,      ffREAD },
         { efNDX, NULL,  NULL,      ffOPTRD },
index 38621c7449247d28a7205f571b7e60b06749275a..7db3e408baf101ef2bf13d4545d542889d59e859 100644 (file)
@@ -813,7 +813,7 @@ static void do_sham(const char *fn, const char *ndx,
     }
 }
 
-static void ehisto(const char *fh, int n, real **enerT, const output_env_t oenv)
+static void ehisto(const char *fh, int n, real **enerT, const gmx_output_env_t *oenv)
 {
     FILE  *fp;
     int    i, j, k, nbin, blength;
@@ -961,14 +961,14 @@ int gmx_sham(int argc, char *argv[])
     };
 #define NPA asize(pa)
 
-    int             n, e_n, nset, e_nset = 0, i, *idim, *ibox;
-    real          **val, **et_val, *t, *e_t, e_dt, dt;
-    real           *rmin, *rmax;
-    const char     *fn_ge, *fn_ene;
-    output_env_t    oenv;
-    gmx_int64_t     num_grid_points;
+    int               n, e_n, nset, e_nset = 0, i, *idim, *ibox;
+    real            **val, **et_val, *t, *e_t, e_dt, dt;
+    real             *rmin, *rmax;
+    const char       *fn_ge, *fn_ene;
+    gmx_output_env_t *oenv;
+    gmx_int64_t       num_grid_points;
 
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efXVG, "-f",    "graph",    ffREAD   },
         { efXVG, "-ge",   "gibbs",    ffOPTRD  },
         { efXVG, "-ene",  "esham",    ffOPTRD  },
index dfa9f9c556467d45ec85c7bf4f5d2e3fc9317592..b6abdaf10e6b686821181d535e4edaa06b5785e3 100644 (file)
@@ -68,16 +68,16 @@ real dpot(real x, real qq, real c6, real cn, int npow)
 
 int gmx_sigeps(int argc, char *argv[])
 {
-    const char   *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] is a simple utility that converts C6/C12 or C6/Cn combinations",
         "to [GRK]sigma[grk] and [GRK]epsilon[grk], or vice versa. It can also plot the potential",
         "in  file. In addition, it makes an approximation of a Buckingham potential",
         "to a Lennard-Jones potential."
     };
-    static real   c6   = 1.0e-3, cn = 1.0e-6, qi = 0, qj = 0, sig = 0.3, eps = 1, sigfac = 0.7;
-    static real   Abh  = 1e5, Bbh = 32, Cbh = 1e-3;
-    static int    npow = 12;
-    t_pargs       pa[] = {
+    static real       c6   = 1.0e-3, cn = 1.0e-6, qi = 0, qj = 0, sig = 0.3, eps = 1, sigfac = 0.7;
+    static real       Abh  = 1e5, Bbh = 32, Cbh = 1e-3;
+    static int        npow = 12;
+    t_pargs           pa[] = {
         { "-c6",   FALSE,  etREAL,  {&c6},  "C6"   },
         { "-cn",   FALSE,  etREAL,  {&cn},  "Constant for repulsion"   },
         { "-pow",  FALSE,  etINT,   {&npow}, "Power of the repulsion term" },
@@ -90,17 +90,17 @@ int gmx_sigeps(int argc, char *argv[])
         { "-qj",   FALSE,  etREAL,  {&qj},  "qj"   },
         { "-sigfac", FALSE, etREAL, {&sigfac}, "Factor in front of [GRK]sigma[grk] for starting the plot" }
     };
-    t_filenm      fnm[] = {
+    t_filenm          fnm[] = {
         { efXVG, "-o", "potje", ffWRITE }
     };
-    output_env_t  oenv;
+    gmx_output_env_t *oenv;
 #define NFILE asize(fnm)
-    const char   *legend[] = { "Lennard-Jones", "Buckingham" };
-    FILE         *fp;
-    int           i;
-    gmx_bool      bBham;
-    real          qq, x, oldx, minimum, mval, dp[2];
-    int           cur = 0;
+    const char       *legend[] = { "Lennard-Jones", "Buckingham" };
+    FILE             *fp;
+    int               i;
+    gmx_bool          bBham;
+    real              qq, x, oldx, minimum, mval, dp[2];
+    int               cur = 0;
 #define next (1-cur)
 
     if (!parse_common_args(&argc, argv, PCA_CAN_VIEW,
index b8e3dfc63c8879b13f3f1f81177bb3140ad18f81..6c3d478a262386e9337f1be37951b1a65fc9346d 100644 (file)
@@ -49,6 +49,7 @@
 #include "gromacs/pbcutil/pbc.h"
 #include "gromacs/pbcutil/rmpbc.h"
 #include "gromacs/topology/index.h"
+#include "gromacs/topology/topology.h"
 #include "gromacs/utility/arraysize.h"
 #include "gromacs/utility/cstringutil.h"
 #include "gromacs/utility/fatalerror.h"
@@ -113,38 +114,38 @@ static void calc_com_pbc(int nrefat, t_topology *top, rvec x[], t_pbc *pbc,
 
 int gmx_sorient(int argc, char *argv[])
 {
-    t_topology      top;
-    int             ePBC = -1;
-    t_trxstatus    *status;
-    int             natoms;
-    real            t;
-    rvec           *xtop, *x;
-    matrix          box;
-
-    FILE           *fp;
-    int             i, p, sa0, sa1, sa2, n, ntot, nf, m, *hist1, *hist2, *histn, nbin1, nbin2, nrbin;
-    real           *histi1, *histi2, invbw, invrbw;
-    double          sum1, sum2;
-    int            *isize, nrefgrp, nrefat;
-    atom_id       **index;
-    char          **grpname;
-    real            inp, outp, nav, normfac, rmin2, rmax2, rcut, rcut2, r2, r;
-    real            c1, c2;
-    char            str[STRLEN];
-    gmx_bool        bTPS;
-    rvec            xref, dx, dxh1, dxh2, outer;
-    gmx_rmpbc_t     gpbc = NULL;
-    t_pbc           pbc;
-    const char     *legr[] = {
+    t_topology        top;
+    int               ePBC = -1;
+    t_trxstatus      *status;
+    int               natoms;
+    real              t;
+    rvec             *xtop, *x;
+    matrix            box;
+
+    FILE             *fp;
+    int               i, p, sa0, sa1, sa2, n, ntot, nf, m, *hist1, *hist2, *histn, nbin1, nbin2, nrbin;
+    real             *histi1, *histi2, invbw, invrbw;
+    double            sum1, sum2;
+    int              *isize, nrefgrp, nrefat;
+    atom_id         **index;
+    char            **grpname;
+    real              inp, outp, nav, normfac, rmin2, rmax2, rcut, rcut2, r2, r;
+    real              c1, c2;
+    char              str[STRLEN];
+    gmx_bool          bTPS;
+    rvec              xref, dx, dxh1, dxh2, outer;
+    gmx_rmpbc_t       gpbc = NULL;
+    t_pbc             pbc;
+    const char       *legr[] = {
         "<cos(\\8q\\4\\s1\\N)>",
         "<3cos\\S2\\N(\\8q\\4\\s2\\N)-1>"
     };
-    const char     *legc[] = {
+    const char       *legc[] = {
         "cos(\\8q\\4\\s1\\N)",
         "3cos\\S2\\N(\\8q\\4\\s2\\N)-1"
     };
 
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] analyzes solvent orientation around solutes.",
         "It calculates two angles between the vector from one or more",
         "reference positions to the first atom of each solvent molecule:",
@@ -169,10 +170,10 @@ int gmx_sorient(int argc, char *argv[])
         "[TT]-rc[tt]: the distribution of the solvent molecules as a function of r"
     };
 
-    output_env_t    oenv;
-    static gmx_bool bCom = FALSE, bVec23 = FALSE, bPBC = FALSE;
-    static real     rmin = 0.0, rmax = 0.5, binwidth = 0.02, rbinw = 0.02;
-    t_pargs         pa[] = {
+    gmx_output_env_t *oenv;
+    static gmx_bool   bCom = FALSE, bVec23 = FALSE, bPBC = FALSE;
+    static real       rmin = 0.0, rmax = 0.5, binwidth = 0.02, rbinw = 0.02;
+    t_pargs           pa[] = {
         { "-com",  FALSE, etBOOL,  {&bCom},
           "Use the center of mass as the reference postion" },
         { "-v23",  FALSE, etBOOL,  {&bVec23},
@@ -184,7 +185,7 @@ int gmx_sorient(int argc, char *argv[])
         { "-pbc",   FALSE, etBOOL, {&bPBC}, "Check PBC for the center of mass calculation. Only necessary when your reference group consists of several molecules." }
     };
 
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efTRX, NULL,  NULL,  ffREAD },
         { efTPS, NULL,  NULL,  ffREAD },
         { efNDX, NULL,  NULL,  ffOPTRD },
index 413aa068110d750abb36285122beb4336c2f8168..770b66e3aed97d07b40c157d8e5592459aa78e4c 100644 (file)
@@ -56,7 +56,7 @@ static const double bohr = 0.529177249;  /* conversion factor to compensate for
 
 int gmx_spatial(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] calculates the spatial distribution function and",
         "outputs it in a form that can be read by VMD as Gaussian98 cube format.",
         "For a system of 32,000 atoms and a 50 ns trajectory, the SDF can be generated",
@@ -99,21 +99,21 @@ int gmx_spatial(int argc, char *argv[])
         "memory is allocated for cube bins based on the initial coordinates and the [TT]-nab[tt]",
         "option value."
     };
-    const char     *bugs[] = {
+    const char       *bugs[] = {
         "When the allocated memory is not large enough, a segmentation fault may occur. This is usually detected "
         "and the program is halted prior to the fault while displaying a warning message suggesting the use of the [TT]-nab[tt] (Number of Additional Bins) "
         "option. However, the program does not detect all such events. If you encounter a segmentation fault, run it again "
         "with an increased [TT]-nab[tt] value."
     };
 
-    static gmx_bool bPBC         = FALSE;
-    static int      iIGNOREOUTER = -1;   /*Positive values may help if the surface is spikey */
-    static gmx_bool bCUTDOWN     = TRUE;
-    static real     rBINWIDTH    = 0.05; /* nm */
-    static gmx_bool bCALCDIV     = TRUE;
-    static int      iNAB         = 4;
+    static gmx_bool   bPBC         = FALSE;
+    static int        iIGNOREOUTER = -1;   /*Positive values may help if the surface is spikey */
+    static gmx_bool   bCUTDOWN     = TRUE;
+    static real       rBINWIDTH    = 0.05; /* nm */
+    static gmx_bool   bCALCDIV     = TRUE;
+    static int        iNAB         = 4;
 
-    t_pargs         pa[] = {
+    t_pargs           pa[] = {
         { "-pbc",      FALSE, etBOOL, {&bPBC},
           "Use periodic boundary conditions for computing distances" },
         { "-div",      FALSE, etBOOL, {&bCALCDIV},
@@ -128,34 +128,34 @@ int gmx_spatial(int argc, char *argv[])
           "Number of additional bins to ensure proper memory allocation" }
     };
 
-    double          MINBIN[3];
-    double          MAXBIN[3];
-    t_topology      top;
-    int             ePBC;
-    t_trxframe      fr;
-    rvec           *xtop;
-    matrix          box, box_pbc;
-    t_trxstatus    *status;
-    int             flags = TRX_READ_X;
-    t_pbc           pbc;
-    t_atoms        *atoms;
-    int             natoms;
-    char           *grpnm, *grpnmp;
-    atom_id        *index, *indexp;
-    int             i, nidx, nidxp;
-    int             v;
-    int             j, k;
-    int          ***bin = NULL;
-    int             nbin[3];
-    FILE           *flp;
-    int             x, y, z, minx, miny, minz, maxx, maxy, maxz;
-    int             numfr, numcu;
-    int             tot, maxval, minval;
-    double          norm;
-    output_env_t    oenv;
-    gmx_rmpbc_t     gpbc = NULL;
+    double            MINBIN[3];
+    double            MAXBIN[3];
+    t_topology        top;
+    int               ePBC;
+    t_trxframe        fr;
+    rvec             *xtop;
+    matrix            box, box_pbc;
+    t_trxstatus      *status;
+    int               flags = TRX_READ_X;
+    t_pbc             pbc;
+    t_atoms          *atoms;
+    int               natoms;
+    char             *grpnm, *grpnmp;
+    atom_id          *index, *indexp;
+    int               i, nidx, nidxp;
+    int               v;
+    int               j, k;
+    int            ***bin = NULL;
+    int               nbin[3];
+    FILE             *flp;
+    int               x, y, z, minx, miny, minz, maxx, maxy, maxz;
+    int               numfr, numcu;
+    int               tot, maxval, minval;
+    double            norm;
+    gmx_output_env_t *oenv;
+    gmx_rmpbc_t       gpbc = NULL;
 
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efTPS,  NULL,  NULL, ffREAD }, /* this is for the topology */
         { efTRX, "-f", NULL, ffREAD },   /* and this for the trajectory */
         { efNDX, NULL, NULL, ffOPTRD }
index aa88ad8159dca80de2c3f2fae8539232908d689a..6e422d51943a1ebc9ad54dfbe961329da45a72d8 100644 (file)
@@ -50,6 +50,7 @@
 #include "gromacs/pbcutil/pbc.h"
 #include "gromacs/pbcutil/rmpbc.h"
 #include "gromacs/topology/index.h"
+#include "gromacs/topology/topology.h"
 #include "gromacs/utility/arraysize.h"
 #include "gromacs/utility/cstringutil.h"
 #include "gromacs/utility/fatalerror.h"
@@ -168,7 +169,7 @@ int gmx_spol(int argc, char *argv[])
     gmx_rmpbc_t  gpbc = NULL;
 
 
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] analyzes dipoles around a solute; it is especially useful",
         "for polarizable water. A group of reference atoms, or a center",
         "of mass reference (option [TT]-com[tt]) and a group of solvent",
@@ -189,11 +190,11 @@ int gmx_spol(int argc, char *argv[])
         "to the midpoint between the second and the third atom."
     };
 
-    output_env_t    oenv;
-    static gmx_bool bCom   = FALSE;
-    static int      srefat = 1;
-    static real     rmin   = 0.0, rmax = 0.32, refdip = 0, bw = 0.01;
-    t_pargs         pa[]   = {
+    gmx_output_env_t *oenv;
+    static gmx_bool   bCom   = FALSE;
+    static int        srefat = 1;
+    static real       rmin   = 0.0, rmax = 0.32, refdip = 0, bw = 0.01;
+    t_pargs           pa[]   = {
         { "-com",  FALSE, etBOOL,  {&bCom},
           "Use the center of mass as the reference postion" },
         { "-refat",  FALSE, etINT, {&srefat},
@@ -204,7 +205,7 @@ int gmx_spol(int argc, char *argv[])
         { "-bw",    FALSE, etREAL, {&bw}, "The bin width" }
     };
 
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efTRX, NULL,  NULL,  ffREAD },
         { efTPR, NULL,  NULL,  ffREAD },
         { efNDX, NULL,  NULL,  ffOPTRD },
index 8f187872980d15d9275e584b5eaf419e8f2ad73e..630d5846e60a1f1c054a91d87af1dddf5ba487cd 100644 (file)
@@ -78,7 +78,7 @@ static void process_tcaf(int nframes, real dt, int nkc, real **tc, rvec *kfac,
                          real rho, real wt, const char *fn_trans,
                          const char *fn_tca, const char *fn_tc,
                          const char *fn_tcf, const char *fn_cub,
-                         const char *fn_vk, const output_env_t oenv)
+                         const char *fn_vk, const gmx_output_env_t *oenv)
 {
     FILE  *fp, *fp_vk, *fp_cub = NULL;
     int    nk, ntc;
@@ -259,7 +259,7 @@ static void process_tcaf(int nframes, real dt, int nkc, real **tc, rvec *kfac,
 
 int gmx_tcaf(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] computes tranverse current autocorrelations.",
         "These are used to estimate the shear viscosity, [GRK]eta[grk].",
         "For details see: Palmer, Phys. Rev. E 49 (1994) pp 359-366.[PAR]",
@@ -293,9 +293,9 @@ int gmx_tcaf(int argc, char *argv[])
         "is very important for obtaining a good fit."
     };
 
-    static gmx_bool bMol = FALSE, bK34 = FALSE;
-    static real     wt   = 5;
-    t_pargs         pa[] = {
+    static gmx_bool   bMol = FALSE, bK34 = FALSE;
+    static real       wt   = 5;
+    t_pargs           pa[] = {
         { "-mol", FALSE, etBOOL, {&bMol},
           "Calculate TCAF of molecules" },
         { "-k34", FALSE, etBOOL, {&bK34},
@@ -304,22 +304,22 @@ int gmx_tcaf(int argc, char *argv[])
           "Exponential decay time for the TCAF fit weights" }
     };
 
-    t_topology      top;
-    int             ePBC;
-    t_trxframe      fr;
-    matrix          box;
-    gmx_bool        bTop;
-    int             gnx;
-    atom_id        *index, *atndx = NULL, at;
-    char           *grpname;
-    char            title[256];
-    real            t0, t1, dt, m, mtot, sysmass, rho, sx, cx;
-    t_trxstatus    *status;
-    int             nframes, n_alloc, i, j, k, d;
-    rvec            mv_mol, cm_mol, kfac[NK];
-    int             nkc, nk, ntc;
-    real          **tc;
-    output_env_t    oenv;
+    t_topology        top;
+    int               ePBC;
+    t_trxframe        fr;
+    matrix            box;
+    gmx_bool          bTop;
+    int               gnx;
+    atom_id          *index, *atndx = NULL, at;
+    char             *grpname;
+    char              title[256];
+    real              t0, t1, dt, m, mtot, sysmass, rho, sx, cx;
+    t_trxstatus      *status;
+    int               nframes, n_alloc, i, j, k, d;
+    rvec              mv_mol, cm_mol, kfac[NK];
+    int               nkc, nk, ntc;
+    real            **tc;
+    gmx_output_env_t *oenv;
 
 #define NHISTO 360
 
index aa77634f211f4a93754ca3a478ed973cc9b52780..8ed20e92a4efec4acf7055272e658d1489e2d6e2 100644 (file)
@@ -209,7 +209,7 @@ static void write_trx_x(t_trxstatus *status, t_trxframe *fr, real *mass, gmx_boo
 
 static void make_legend(FILE *fp, int ngrps, int isize, atom_id index[],
                         char **name, gmx_bool bCom, gmx_bool bMol, gmx_bool bDim[],
-                        const output_env_t oenv)
+                        const gmx_output_env_t *oenv)
 {
     char      **leg;
     const char *dimtxt[] = { " X", " Y", " Z", "" };
@@ -422,7 +422,7 @@ static void write_pdb_bfac(const char *fname, const char *xname,
                            int isize, atom_id *index, int nfr_x, rvec *x,
                            int nfr_v, rvec *sum,
                            gmx_bool bDim[], real scale_factor,
-                           const output_env_t oenv)
+                           const gmx_output_env_t *oenv)
 {
     FILE       *fp;
     real        max, len2, scale;
@@ -576,7 +576,7 @@ static void update_histo(int gnx, atom_id index[], rvec v[],
 }
 
 static void print_histo(const char *fn, int nhisto, int histo[], real binwidth,
-                        const output_env_t oenv)
+                        const gmx_output_env_t *oenv)
 {
     FILE *fp;
     int   i;
@@ -592,7 +592,7 @@ static void print_histo(const char *fn, int nhisto, int histo[], real binwidth,
 
 int gmx_traj(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] plots coordinates, velocities, forces and/or the box.",
         "With [TT]-com[tt] the coordinates, velocities and forces are",
         "calculated for the center of mass of each group.",
@@ -623,11 +623,11 @@ int gmx_traj(int argc, char *argv[])
         "norm of the vector is plotted. In addition in the same graph",
         "the kinetic energy distribution is given."
     };
-    static gmx_bool bMol    = FALSE, bCom = FALSE, bPBC = TRUE, bNoJump = FALSE;
-    static gmx_bool bX      = TRUE, bY = TRUE, bZ = TRUE, bNorm = FALSE, bFP = FALSE;
-    static int      ngroups = 1;
-    static real     ctime   = -1, scale = 0, binwidth = 1;
-    t_pargs         pa[]    = {
+    static gmx_bool   bMol    = FALSE, bCom = FALSE, bPBC = TRUE, bNoJump = FALSE;
+    static gmx_bool   bX      = TRUE, bY = TRUE, bZ = TRUE, bNorm = FALSE, bFP = FALSE;
+    static int        ngroups = 1;
+    static real       ctime   = -1, scale = 0, binwidth = 1;
+    t_pargs           pa[]    = {
         { "-com", FALSE, etBOOL, {&bCom},
           "Plot data for the com of each group" },
         { "-pbc", FALSE, etBOOL, {&bPBC},
@@ -655,34 +655,34 @@ int gmx_traj(int argc, char *argv[])
         { "-scale", FALSE, etREAL, {&scale},
           "Scale factor for [REF].pdb[ref] output, 0 is autoscale" }
     };
-    FILE           *outx   = NULL, *outv = NULL, *outf = NULL, *outb = NULL, *outt = NULL;
-    FILE           *outekt = NULL, *outekr = NULL;
-    t_topology      top;
-    int             ePBC;
-    real           *mass, time;
-    const char     *indexfn;
-    t_trxframe      fr, frout;
-    int             flags, nvhisto = 0, *vhisto = NULL;
-    rvec           *xtop, *xp = NULL;
-    rvec           *sumx = NULL, *sumv = NULL, *sumf = NULL;
-    matrix          topbox;
-    t_trxstatus    *status;
-    t_trxstatus    *status_out = NULL;
-    gmx_rmpbc_t     gpbc       = NULL;
-    int             i, j;
-    int             nr_xfr, nr_vfr, nr_ffr;
-    char          **grpname;
-    int            *isize0, *isize;
-    atom_id       **index0, **index;
-    atom_id        *atndx;
-    t_block        *mols;
-    gmx_bool        bTop, bOX, bOXT, bOV, bOF, bOB, bOT, bEKT, bEKR, bCV, bCF;
-    gmx_bool        bDim[4], bDum[4], bVD;
-    char            sffmt[STRLEN], sffmt6[STRLEN];
-    const char     *box_leg[6] = { "XX", "YY", "ZZ", "YX", "ZX", "ZY" };
-    output_env_t    oenv;
-
-    t_filenm        fnm[] = {
+    FILE             *outx   = NULL, *outv = NULL, *outf = NULL, *outb = NULL, *outt = NULL;
+    FILE             *outekt = NULL, *outekr = NULL;
+    t_topology        top;
+    int               ePBC;
+    real             *mass, time;
+    const char       *indexfn;
+    t_trxframe        fr, frout;
+    int               flags, nvhisto = 0, *vhisto = NULL;
+    rvec             *xtop, *xp = NULL;
+    rvec             *sumx = NULL, *sumv = NULL, *sumf = NULL;
+    matrix            topbox;
+    t_trxstatus      *status;
+    t_trxstatus      *status_out = NULL;
+    gmx_rmpbc_t       gpbc       = NULL;
+    int               i, j;
+    int               nr_xfr, nr_vfr, nr_ffr;
+    char            **grpname;
+    int              *isize0, *isize;
+    atom_id         **index0, **index;
+    atom_id          *atndx;
+    t_block          *mols;
+    gmx_bool          bTop, bOX, bOXT, bOV, bOF, bOB, bOT, bEKT, bEKR, bCV, bCF;
+    gmx_bool          bDim[4], bDum[4], bVD;
+    char              sffmt[STRLEN], sffmt6[STRLEN];
+    const char       *box_leg[6] = { "XX", "YY", "ZZ", "YX", "ZX", "ZY" };
+    gmx_output_env_t *oenv;
+
+    t_filenm          fnm[] = {
         { efTRX, "-f", NULL, ffREAD },
         { efTPS, NULL, NULL, ffREAD },
         { efNDX, NULL, NULL, ffOPTRD },
index b0002be4c9a412852dc185de0b03cf3e01ba1021..be4dcb24813ec0a12fa16895b9a6f58534a018c9 100644 (file)
@@ -72,7 +72,7 @@
 
 static void scan_trj_files(char **fnms, int nfiles, real *readtime,
                            real *timestep, atom_id imax,
-                           const output_env_t oenv)
+                           const gmx_output_env_t *oenv)
 {
     /* Check start time of all files */
     int          i, natoms = 0;
@@ -179,7 +179,7 @@ static void sort_files(char **fnms, real *settime, int nfile)
 
 static void edit_files(char **fnms, int nfiles, real *readtime, real *timestep,
                        real *settime, int *cont_type, gmx_bool bSetTime,
-                       gmx_bool bSort, const output_env_t oenv)
+                       gmx_bool bSort, const gmx_output_env_t *oenv)
 {
     int      i;
     gmx_bool ok;
@@ -310,7 +310,7 @@ static void edit_files(char **fnms, int nfiles, real *readtime, real *timestep,
 
 static void do_demux(int nset, char *fnms[], char *fnms_out[], int nval,
                      real **value, real *time, real dt_remd, int isize,
-                     atom_id index[], real dt, const output_env_t oenv)
+                     atom_id index[], real dt, const gmx_output_env_t *oenv)
 {
     int           i, j, k, natoms, nnn;
     t_trxstatus **fp_in, **fp_out;
@@ -474,25 +474,25 @@ int gmx_trjcat(int argc, char *argv[])
           { &bCat }, "Do not discard double time frames" }
     };
 #define npargs asize(pa)
-    int          ftpin, i, frame, frame_out;
-    t_trxstatus *status, *trxout = NULL;
-    real         t_corr;
-    t_trxframe   fr, frout;
-    char       **fnms, **fnms_out, *out_file;
-    int          n_append;
-    gmx_bool     bNewFile, bIndex, bWrite;
-    int          nfile_in, nfile_out, *cont_type;
-    real        *readtime, *timest, *settime;
-    real         first_time = 0, lasttime = NOTSET, last_ok_t = -1, timestep;
-    real         last_frame_time, searchtime;
-    int          isize = 0, j;
-    atom_id     *index = NULL, imax;
-    char        *grpname;
-    real       **val = NULL, *t = NULL, dt_remd;
-    int          n, nset, ftpout = -1, prevEndStep = 0, filetype;
-    gmx_off_t    fpos;
-    output_env_t oenv;
-    t_filenm     fnm[] =
+    int               ftpin, i, frame, frame_out;
+    t_trxstatus      *status, *trxout = NULL;
+    real              t_corr;
+    t_trxframe        fr, frout;
+    char            **fnms, **fnms_out, *out_file;
+    int               n_append;
+    gmx_bool          bNewFile, bIndex, bWrite;
+    int               nfile_in, nfile_out, *cont_type;
+    real             *readtime, *timest, *settime;
+    real              first_time = 0, lasttime = NOTSET, last_ok_t = -1, timestep;
+    real              last_frame_time, searchtime;
+    int               isize = 0, j;
+    atom_id          *index = NULL, imax;
+    char             *grpname;
+    real            **val = NULL, *t = NULL, dt_remd;
+    int               n, nset, ftpout = -1, prevEndStep = 0, filetype;
+    gmx_off_t         fpos;
+    gmx_output_env_t *oenv;
+    t_filenm          fnm[] =
     {
         { efTRX, "-f", NULL, ffRDMULT },
         { efTRO, "-o", NULL, ffWRMULT },
index 7f934f375e41930f9d5b62ae05e04d5be9008bf2..d17a81132e326ea649f97dfe85a3d97d1d219d04 100644 (file)
@@ -905,7 +905,7 @@ int gmx_trjconv(int argc, char *argv[])
     char             *outf_base = NULL;
     const char       *outf_ext  = NULL;
     char              top_title[256], title[256], filemode[5];
-    output_env_t      oenv;
+    gmx_output_env_t *oenv;
 
     t_filenm          fnm[] = {
         { efTRX, "-f",   NULL,      ffREAD  },
index c15074a777ba2e42756864e073c31c520d6a19d7..d7af88dcc35a5e77c33a3e1e439693791cfba163 100644 (file)
@@ -83,7 +83,7 @@ static int ocomp(const void *a, const void *b)
 
 int gmx_trjorder(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] orders molecules according to the smallest distance",
         "to atoms in a reference group",
         "or on z-coordinate (with option [TT]-z[tt]).",
@@ -108,10 +108,10 @@ int gmx_trjorder(int argc, char *argv[])
         "With option [TT]-nshell[tt] the number of molecules within a shell",
         "of radius [TT]-r[tt] around the reference group are printed."
     };
-    static int      na   = 3, ref_a = 1;
-    static real     rcut = 0;
-    static gmx_bool bCOM = FALSE, bZ = FALSE;
-    t_pargs         pa[] = {
+    static int        na   = 3, ref_a = 1;
+    static real       rcut = 0;
+    static gmx_bool   bCOM = FALSE, bZ = FALSE;
+    t_pargs           pa[] = {
         { "-na", FALSE, etINT,  {&na},
           "Number of atoms in a molecule" },
         { "-da", FALSE, etINT,  {&ref_a},
@@ -123,23 +123,23 @@ int gmx_trjorder(int argc, char *argv[])
         { "-z", FALSE, etBOOL, {&bZ},
           "Order molecules on z-coordinate" }
     };
-    FILE           *fp;
-    t_trxstatus    *out;
-    t_trxstatus    *status;
-    gmx_bool        bNShell, bPDBout;
-    t_topology      top;
-    int             ePBC;
-    rvec           *x, *xsol, xcom, dx;
-    matrix          box;
-    t_pbc           pbc;
-    gmx_rmpbc_t     gpbc;
-    real            t, totmass, mass, rcut2 = 0, n2;
-    int             natoms, nwat, ncut;
-    char          **grpname;
-    int             i, j, d, *isize, isize_ref = 0, isize_sol;
-    atom_id         sa, sr, *swi, **index, *ind_ref = NULL, *ind_sol;
-    output_env_t    oenv;
-    t_filenm        fnm[] = {
+    FILE             *fp;
+    t_trxstatus      *out;
+    t_trxstatus      *status;
+    gmx_bool          bNShell, bPDBout;
+    t_topology        top;
+    int               ePBC;
+    rvec             *x, *xsol, xcom, dx;
+    matrix            box;
+    t_pbc             pbc;
+    gmx_rmpbc_t       gpbc;
+    real              t, totmass, mass, rcut2 = 0, n2;
+    int               natoms, nwat, ncut;
+    char            **grpname;
+    int               i, j, d, *isize, isize_ref = 0, isize_sol;
+    atom_id           sa, sr, *swi, **index, *ind_ref = NULL, *ind_sol;
+    gmx_output_env_t *oenv;
+    t_filenm          fnm[] = {
         { efTRX, "-f", NULL, ffREAD  },
         { efTPS, NULL, NULL, ffREAD  },
         { efNDX, NULL, NULL, ffOPTRD },
index 06c712ca72c2c5eb5547d31454c4972c8de174a9..687b0de3c6ec00187f10ed36e3d714d0648595bc 100644 (file)
@@ -2309,15 +2309,15 @@ int gmx_tune_pme(int argc, char *argv[])
     const char     *npmevalues_opt[] =
     { NULL, "auto", "all", "subset", NULL };
 
-    gmx_bool     bAppendFiles          = TRUE;
-    gmx_bool     bKeepAndNumCPT        = FALSE;
-    gmx_bool     bResetCountersHalfWay = FALSE;
-    gmx_bool     bBenchmark            = TRUE;
-    gmx_bool     bCheck                = TRUE;
+    gmx_bool          bAppendFiles          = TRUE;
+    gmx_bool          bKeepAndNumCPT        = FALSE;
+    gmx_bool          bResetCountersHalfWay = FALSE;
+    gmx_bool          bBenchmark            = TRUE;
+    gmx_bool          bCheck                = TRUE;
 
-    output_env_t oenv = NULL;
+    gmx_output_env_t *oenv = NULL;
 
-    t_pargs      pa[] = {
+    t_pargs           pa[] = {
         /***********************/
         /* g_tune_pme options: */
         /***********************/
index 6c7ca6d724302b138b621e860760a7d52e0fb42e..4b21a652c8af21da3af6e52145189adbcc41d576 100644 (file)
@@ -128,24 +128,24 @@ int gmx_vanhove(int argc, char *argv[])
     };
 #define NFILE asize(fnm)
 
-    output_env_t oenv;
-    const char  *matfile, *otfile, *orfile;
-    t_topology   top;
-    int          ePBC;
-    matrix       boxtop, box, *sbox, avbox, corr;
-    rvec        *xtop, *x, **sx;
-    int          isize, nalloc, nallocn;
-    t_trxstatus *status;
-    atom_id     *index;
-    char        *grpname;
-    int          nfr, f, ff, i, m, mat_nx = 0, nbin = 0, bin, mbin, fbin;
-    real        *time, t, invbin = 0, rmax2 = 0, rint2 = 0, d2;
-    real         invsbin = 0, matmax, normfac, dt, *tickx, *ticky;
-    char         buf[STRLEN], **legend;
-    real       **mat = NULL;
-    int         *pt  = NULL, **pr = NULL, *mcount = NULL, *tcount = NULL, *rcount = NULL;
-    FILE        *fp;
-    t_rgb        rlo = {1, 1, 1}, rhi = {0, 0, 0};
+    gmx_output_env_t *oenv;
+    const char       *matfile, *otfile, *orfile;
+    t_topology        top;
+    int               ePBC;
+    matrix            boxtop, box, *sbox, avbox, corr;
+    rvec             *xtop, *x, **sx;
+    int               isize, nalloc, nallocn;
+    t_trxstatus      *status;
+    atom_id          *index;
+    char             *grpname;
+    int               nfr, f, ff, i, m, mat_nx = 0, nbin = 0, bin, mbin, fbin;
+    real             *time, t, invbin = 0, rmax2 = 0, rint2 = 0, d2;
+    real              invsbin = 0, matmax, normfac, dt, *tickx, *ticky;
+    char              buf[STRLEN], **legend;
+    real            **mat = NULL;
+    int              *pt  = NULL, **pr = NULL, *mcount = NULL, *tcount = NULL, *rcount = NULL;
+    FILE             *fp;
+    t_rgb             rlo = {1, 1, 1}, rhi = {0, 0, 0};
 
     if (!parse_common_args(&argc, argv, PCA_CAN_VIEW | PCA_CAN_TIME,
                            NFILE, fnm, asize(pa), pa, asize(desc), desc, 0, NULL, &oenv))
index c026ec5949a5dd8f1a8a998eab4e0ee43a3ea00e..2df13d056f7c30f5e7f90d9e6b358d9ac535eb06 100644 (file)
@@ -122,7 +122,7 @@ static void precalc(t_topology top, real normm[])
 }
 
 static void calc_spectrum(int n, real c[], real dt, const char *fn,
-                          output_env_t oenv, gmx_bool bRecip)
+                          gmx_output_env_t *oenv, gmx_bool bRecip)
 {
     FILE     *fp;
     gmx_fft_t fft;
@@ -219,7 +219,7 @@ int gmx_velacc(int argc, char *argv[])
     /* Array for the correlation function */
     real            **c1;
     real             *normm = NULL;
-    output_env_t      oenv;
+    gmx_output_env_t *oenv;
 
 #define NHISTO 360
 
index 6cd7f73d1dff29348a55b1e18989e2e7fb18a559..5e290121d4b9478dbc773472155a594cf992b283 100644 (file)
@@ -231,15 +231,15 @@ typedef struct
     /*! \brief after wham, set prof to zero at this z-position.
      * When bootstrapping, set zProf0 to a "stable" reference position.
      */
-    real         zProf0;
-    gmx_bool     bProf0Set;              //!< setting profile to 0 at zProf0?
+    real              zProf0;
+    gmx_bool          bProf0Set;              //!< setting profile to 0 at zProf0?
 
-    gmx_bool     bBoundsOnly, bHistOnly; //!< determine min and max, or write histograms and exit
-    gmx_bool     bAuto;                  //!< determine min and max automatically but do not exit
+    gmx_bool          bBoundsOnly, bHistOnly; //!< determine min and max, or write histograms and exit
+    gmx_bool          bAuto;                  //!< determine min and max automatically but do not exit
 
-    gmx_bool     verbose;                //!< more noisy wham mode
-    int          stepchange;             //!< print maximum change in prof after how many interations
-    output_env_t oenv;                   //!< xvgr options
+    gmx_bool          verbose;                //!< more noisy wham mode
+    int               stepchange;             //!< print maximum change in prof after how many interations
+    gmx_output_env_t *oenv;                   //!< xvgr options
     /*!\}*/
     /*!
      * \name Autocorrelation stuff
index 682004a13ab109af952d22858f8fd2dbab411891..8dc3d124582bc07d2ba4c41d0ad73978f2ac8af8 100644 (file)
@@ -216,18 +216,18 @@ void wheel2(const char *fn, int nres, char *resnm[], real rot0, char *title)
 
 int gmx_wheel(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] plots a helical wheel representation of your sequence.",
         "The input sequence is in the [REF].dat[ref] file where the first line contains",
         "the number of residues and each consecutive line contains a residue "
         "name."
     };
-    output_env_t    oenv;
-    static real     rot0  = 0;
-    static gmx_bool bNum  = TRUE;
-    static char    *title = NULL;
-    static int      r0    = 1;
-    t_pargs         pa [] = {
+    gmx_output_env_t *oenv;
+    static real       rot0  = 0;
+    static gmx_bool   bNum  = TRUE;
+    static char      *title = NULL;
+    static int        r0    = 1;
+    t_pargs           pa [] = {
         { "-r0",  FALSE, etINT, {&r0},
           "The first residue number in the sequence" },
         { "-rot0", FALSE, etREAL, {&rot0},
@@ -237,7 +237,7 @@ int gmx_wheel(int argc, char *argv[])
         { "-nn",  FALSE, etBOOL, {&bNum},
           "Toggle numbers" }
     };
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efDAT, "-f", NULL,  ffREAD  },
         { efEPS, "-o", NULL,  ffWRITE }
     };
index eb32b90059d0e7ff3870c463b8b11f542ab0a3d8..410b16a612cc7d9ec6f7184498db5965b1ebc1e2 100644 (file)
@@ -1385,7 +1385,7 @@ void rainbow_mat(gmx_bool bBlue, int nmat, t_matrix mat[])
 
 int gmx_xpm2ps(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] makes a beautiful color plot of an XPixelMap file.",
         "Labels and axis can be displayed, when they are supplied",
         "in the correct matrix format.",
@@ -1428,14 +1428,14 @@ int gmx_xpm2ps(int argc, char *argv[])
         "the [TT]-xpm[tt] option."
     };
 
-    output_env_t    oenv;
-    const char     *fn, *epsfile = NULL, *xpmfile = NULL;
-    int             i, nmat, nmat2, etitle, elegend, ediag, erainbow, ecombine;
-    t_matrix       *mat = NULL, *mat2 = NULL;
-    gmx_bool        bTitle, bTitleOnce, bDiag, bFirstDiag, bGrad;
-    static gmx_bool bFrame = TRUE, bZeroLine = FALSE, bYonce = FALSE;
-    static real     size   = 400, boxx = 0, boxy = 0, cmin = 0, cmax = 0;
-    static rvec     grad   = {0, 0, 0};
+    gmx_output_env_t *oenv;
+    const char       *fn, *epsfile = NULL, *xpmfile = NULL;
+    int               i, nmat, nmat2, etitle, elegend, ediag, erainbow, ecombine;
+    t_matrix         *mat = NULL, *mat2 = NULL;
+    gmx_bool          bTitle, bTitleOnce, bDiag, bFirstDiag, bGrad;
+    static gmx_bool   bFrame = TRUE, bZeroLine = FALSE, bYonce = FALSE;
+    static real       size   = 400, boxx = 0, boxy = 0, cmin = 0, cmax = 0;
+    static rvec       grad   = {0, 0, 0};
     enum                    {
         etSel, etTop, etOnce, etYlabel, etNone, etNR
     };
index 8bf393577e99c15aa0cecb7259e7ff79b9abeb9a..b68ecd34899edb11726074e6a375ef2b2c3baa1b 100644 (file)
 #define GMX_GMXANA_GSTAT_H
 
 #include "gromacs/commandline/pargs.h"
-#include "gromacs/legacyheaders/typedefs.h"
-#include "gromacs/legacyheaders/types/oenv.h"
 #include "gromacs/topology/index.h"
 
 #ifdef __cplusplus
 extern "C" {
 #endif
 
+struct gmx_output_env_t;
 struct gmx_residuetype_t;
 
 /* must correspond with 'leg' g_chi.c:727 */
@@ -116,7 +115,7 @@ void calc_distribution_props(int nh, int histo[],
 void ana_dih_trans(const char *fn_trans, const char *fn_histo,
                    real **dih, int nframes, int nangles,
                    const char *grpname, real *time, gmx_bool bRb,
-                   const output_env_t oenv);
+                   const gmx_output_env_t *oenv);
 /*
  * Analyse dihedral transitions, by counting transitions per dihedral
  * and per frame. The total number of transitions is printed to
@@ -145,7 +144,7 @@ void low_ana_dih_trans(gmx_bool bTrans, const char *fn_trans,
                        real **dih, int nlist, t_dlist dlist[],
                        int nframes, int nangles, const char *grpname,
                        int multiplicity[], real *time, gmx_bool bRb,
-                       real core_frac, const output_env_t oenv);
+                       real core_frac, const gmx_output_env_t *oenv);
 /* as above but passes dlist so can copy occupancies into it, and multiplicity[]
  *  (1..nangles, corresp to dih[this][], so can have non-3 multiplicity of
  * rotamers. Also production of xvg output files is conditional
@@ -163,7 +162,7 @@ void read_ang_dih(const char *trj_fn,
                   real **trans_frac,
                   real **aver_angle,
                   real *dih[],
-                  const output_env_t oenv);
+                  const gmx_output_env_t *oenv);
 /*
  * Read a trajectory and calculate angles and dihedrals.
  *
@@ -243,9 +242,9 @@ void get_chi_product_traj (real **dih, int nframes,
                            real time[], int **lookup, int *multiplicity,
                            gmx_bool bRb, gmx_bool bNormalize,
                            real core_frac, gmx_bool bAll, const char *fnall,
-                           const output_env_t oenv);
+                           const gmx_output_env_t *oenv);
 
-void print_one (const output_env_t oenv, const char *base,
+void print_one (const gmx_output_env_t *oenv, const char *base,
                 const char *name,
                 const char *title, const char *ylabel, int nf,
                 real time[], real data[]);
index cc1cf7b0625432d3b12b585e6eb5e999150bdee7..e1902b955d1afd879ff33c45e883ed8480c38f0d 100644 (file)
@@ -279,7 +279,7 @@ static void get_dih_props(t_xrama *xr, t_idef *idef, int mult)
 
 
 
-t_topology *init_rama(const output_env_t oenv, const char *infile,
+t_topology *init_rama(gmx_output_env_t *oenv, const char *infile,
                       const char *topfile, t_xrama *xr, int mult)
 {
     t_topology *top;
index b6be328e96a9aec1152b02b95450e1ee29859e9a..6c883f7f2c777ac32d2a2ccca3c2c35da4ac0ac8 100644 (file)
 #define GMX_GMXANA_NRAMA_H
 
 #include "gromacs/fileio/trxio.h"
-#include "gromacs/legacyheaders/typedefs.h"
-#include "gromacs/legacyheaders/types/oenv.h"
+#include "gromacs/topology/topology.h"
+#include "gromacs/utility/real.h"
+
+struct gmx_output_env_t;
 
 #ifdef __cplusplus
 extern "C" {
@@ -60,22 +62,22 @@ typedef struct {
 } t_dih;
 
 typedef struct {
-    int          ndih;
-    t_dih       *dih;
-    int          npp;
-    t_phipsi    *pp;
-    t_trxstatus *traj;
-    int          natoms;
-    int          amin, amax;
-    real         t;
-    rvec        *x;
-    matrix       box;
-    t_idef      *idef;
-    int          ePBC;
-    output_env_t oenv;
+    int               ndih;
+    t_dih            *dih;
+    int               npp;
+    t_phipsi         *pp;
+    t_trxstatus      *traj;
+    int               natoms;
+    int               amin, amax;
+    real              t;
+    rvec             *x;
+    matrix            box;
+    t_idef           *idef;
+    int               ePBC;
+    gmx_output_env_t *oenv;
 } t_xrama;
 
-t_topology *init_rama(const output_env_t oenv, const char *infile,
+t_topology *init_rama(gmx_output_env_t *oenv, const char *infile,
                       const char *topfile, t_xrama *xr, int mult);
 
 gmx_bool new_data(t_xrama *xr);
index 72522cbc92493eb0a56dff4b3dc08a4a40474c94..f13a9b681540d4ebed3a2895ba61f271712e0021 100644 (file)
@@ -442,7 +442,7 @@ extern int do_scattering_intensity (const char* fnTPS, const char* fnNDX,
                                     const char* fnXVG, const char *fnTRX,
                                     const char* fnDAT,
                                     real start_q, real end_q,
-                                    real energy, int ng, const output_env_t oenv)
+                                    real energy, int ng, const gmx_output_env_t *oenv)
 {
     int                     i, *isize, flags = TRX_READ_X, **index_atp;
     t_trxstatus            *status;
@@ -551,7 +551,7 @@ extern int do_scattering_intensity (const char* fnTPS, const char* fnNDX,
 
 
 extern void save_data (structure_factor_t *sft, const char *file, int ngrps,
-                       real start_q, real end_q, const output_env_t oenv)
+                       real start_q, real end_q, const gmx_output_env_t *oenv)
 {
 
     FILE             *fp;
index 8a79b326210b66bca11b3f44fbdb9bad1d229d9c..32d526ae4ac81663d1b77e88f541b8a490fee2ec 100644 (file)
@@ -37,7 +37,6 @@
 #ifndef _sfactor_h
 #define _sfactor_h
 
-#include "gromacs/legacyheaders/types/oenv.h"
 #include "gromacs/legacyheaders/types/simple.h"
 #include "gromacs/math/gmxcomplex.h"
 
@@ -45,6 +44,7 @@
 extern "C" {
 #endif
 
+struct gmx_output_env_t;
 struct t_topology;
 struct t_trxframe;
 
@@ -70,7 +70,7 @@ real **gmx_structurefactors_table(gmx_structurefactors_t *gsf, real momentum, re
                                   real lambda, int n_angles);
 
 void save_data (structure_factor_t * sft, const char *file, int ngrps,
-                real start_q, real end_q, const output_env_t oenv);
+                real start_q, real end_q, const gmx_output_env_t *oenv);
 
 double CMSF (gmx_structurefactors_t *gsf, int type, int nh, double lambda, double sin_theta);
 
@@ -83,7 +83,7 @@ int do_scattering_intensity (const char* fnTPS, const char* fnNDX,
                              const char* fnXVG, const char *fnTRX,
                              const char* fnDAT,
                              real start_q, real end_q,
-                             real energy, int ng, const output_env_t oenv);
+                             real energy, int ng, const gmx_output_env_t *oenv);
 
 t_complex *** rc_tensor_allocation(int x, int y, int z);
 
index 36443056a293c45e9d98dec484cf28f56d9ce015..36634a010e76ae76a26e2ff6fdb358f939823e73 100644 (file)
@@ -125,7 +125,7 @@ static void move_x(int natoms, rvec x[], matrix box)
 
 int gmx_genconf(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] multiplies a given coordinate file by simply stacking them",
         "on top of each other, like a small child playing with wooden blocks.",
         "The program makes a grid of [IT]user-defined[it]",
@@ -140,43 +140,43 @@ int gmx_genconf(int argc, char *argv[])
         "build the grid."
 
     };
-    const char     *bugs[] = {
+    const char       *bugs[] = {
         "The program should allow for random displacement of lattice points."
     };
 
-    int             vol;
-    t_atoms        *atoms;      /* list with all atoms */
-    rvec           *x, *xx, *v; /* coordinates? */
-    real            t;
-    vec4           *xrot, *vrot;
-    int             ePBC;
-    matrix          box, boxx; /* box length matrix */
-    rvec            shift;
-    int             natoms;    /* number of atoms in one molecule  */
-    int             nres;      /* number of molecules? */
-    int             i, j, k, l, m, ndx, nrdx, nx, ny, nz;
-    t_trxstatus    *status;
-    gmx_bool        bTRX;
-    output_env_t    oenv;
-    gmx_rng_t       rng;
-
-    t_filenm        fnm[] = {
+    int               vol;
+    t_atoms          *atoms;      /* list with all atoms */
+    rvec             *x, *xx, *v; /* coordinates? */
+    real              t;
+    vec4             *xrot, *vrot;
+    int               ePBC;
+    matrix            box, boxx; /* box length matrix */
+    rvec              shift;
+    int               natoms;    /* number of atoms in one molecule  */
+    int               nres;      /* number of molecules? */
+    int               i, j, k, l, m, ndx, nrdx, nx, ny, nz;
+    t_trxstatus      *status;
+    gmx_bool          bTRX;
+    gmx_output_env_t *oenv;
+    gmx_rng_t         rng;
+
+    t_filenm          fnm[] = {
         { efSTX, "-f", "conf", ffREAD  },
         { efSTO, "-o", "out",  ffWRITE },
         { efTRX, "-trj", NULL,  ffOPTRD }
     };
 #define NFILE asize(fnm)
-    static rvec     nrbox    = {1, 1, 1};
-    static int      seed     = 0;    /* seed for random number generator */
-    static int      nmolat   = 3;
-    static int      nblock   = 1;
-    static gmx_bool bShuffle = FALSE;
-    static gmx_bool bSort    = FALSE;
-    static gmx_bool bRandom  = FALSE;           /* False: no random rotations */
-    static gmx_bool bRenum   = TRUE;            /* renumber residues */
-    static rvec     dist     = {0, 0, 0};       /* space added between molecules ? */
-    static rvec     max_rot  = {180, 180, 180}; /* maximum rotation */
-    t_pargs         pa[]     = {
+    static rvec       nrbox    = {1, 1, 1};
+    static int        seed     = 0;  /* seed for random number generator */
+    static int        nmolat   = 3;
+    static int        nblock   = 1;
+    static gmx_bool   bShuffle = FALSE;
+    static gmx_bool   bSort    = FALSE;
+    static gmx_bool   bRandom  = FALSE;           /* False: no random rotations */
+    static gmx_bool   bRenum   = TRUE;            /* renumber residues */
+    static rvec       dist     = {0, 0, 0};       /* space added between molecules ? */
+    static rvec       max_rot  = {180, 180, 180}; /* maximum rotation */
+    t_pargs           pa[]     = {
         { "-nbox",   FALSE, etRVEC, {nrbox},   "Number of boxes" },
         { "-dist",   FALSE, etRVEC, {dist},    "Distance between boxes" },
         { "-seed",   FALSE, etINT,  {&seed},
index 324ed189fc2fd75efd5678a425d9c168ae51297b..4c4357b29a02fc61adf77d4eb721576675ae5253 100644 (file)
@@ -716,7 +716,7 @@ static void cont_status(const char *slog, const char *ener,
                         gmx_bool bNeedVel, gmx_bool bGenVel, real fr_time,
                         t_inputrec *ir, t_state *state,
                         gmx_mtop_t *sys,
-                        const output_env_t oenv)
+                        const gmx_output_env_t *oenv)
 /* If fr_time == -1 read the last frame available which is complete */
 {
     gmx_bool     bReadVel;
@@ -1520,7 +1520,7 @@ int gmx_grompp(int argc, char *argv[])
     int                ntype;
     gmx_bool           bNeedVel, bGenVel;
     gmx_bool           have_atomnumber;
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
     gmx_bool           bVerbose = FALSE;
     warninp_t          wi;
     char               warn_buf[STRLEN];
index 14cedc5d2ae4d1b04e22448bcbe1195484f3fc75..9d53a9fa804e3f4e1a11c38e2aa2eccc3bc92816 100644 (file)
@@ -1281,7 +1281,7 @@ int gmx_pdb2gmx(int argc, char *argv[])
     real              mHmult  = 0;
     t_hackblock      *hb_chain;
     t_restp          *restp_chain;
-    output_env_t      oenv;
+    gmx_output_env_t *oenv;
     const char       *p_restype;
     int               rc;
     int               this_atomnum;
index 6cd05214031d71aaf2d6d8edd8cec6f54b9c082e..1093ccd80af9f03b3d3ee2349b463e5aa8bc24de 100644 (file)
@@ -42,6 +42,7 @@
 #include "gromacs/gmxpreprocess/grompp-impl.h"
 #include "gromacs/legacyheaders/typedefs.h"
 
+struct gmx_output_env_t;
 struct pull_params_t;
 struct t_adress;
 struct t_grpopts;
@@ -138,7 +139,7 @@ void make_pull_coords(pull_params_t *pull);
 /* Process the pull coordinates after reading the pull groups */
 
 void set_pull_init(t_inputrec *ir, gmx_mtop_t *mtop, rvec *x, matrix box, real lambda,
-                   const output_env_t oenv);
+                   const gmx_output_env_t *oenv);
 /* Prints the initial pull group distances in x.
  * If requested, adds the current distance to the initial reference location.
  */
index 413063cd34084e3085a2449cf42478e60f53c202..5ed0fd9f8d06d1127fc72c6926ac284e878d3d47 100644 (file)
@@ -419,7 +419,7 @@ void make_pull_coords(pull_params_t *pull)
 }
 
 void set_pull_init(t_inputrec *ir, gmx_mtop_t *mtop, rvec *x, matrix box, real lambda,
-                   const output_env_t oenv)
+                   const gmx_output_env_t *oenv)
 {
     pull_params_t *pull;
     struct pull_t *pull_work;
index 0bcc5fc0ef530e523a2f9bf9a5f0d93b16b6e213..af5390c2b28ce3177176f395826f331896160e64 100644 (file)
@@ -907,12 +907,12 @@ int gmx_solvate(int argc, char *argv[])
     };
 #define NFILE asize(fnm)
 
-    static real     defaultDistance = 0.105, r_shell = 0, scaleFactor = 0.57;
-    static rvec     new_box         = {0.0, 0.0, 0.0};
-    static gmx_bool bReadV          = FALSE;
-    static int      max_sol         = 0;
-    output_env_t    oenv;
-    t_pargs         pa[]              = {
+    static real       defaultDistance = 0.105, r_shell = 0, scaleFactor = 0.57;
+    static rvec       new_box         = {0.0, 0.0, 0.0};
+    static gmx_bool   bReadV          = FALSE;
+    static int        max_sol         = 0;
+    gmx_output_env_t *oenv;
+    t_pargs           pa[]              = {
         { "-box",    FALSE, etRVEC, {new_box},
           "Box size (in nm)" },
         { "-radius",   FALSE, etREAL, {&defaultDistance},
index 02648d5e779869c18efb53acdc4ed53efd9cb867..508e729ca4f2aa5ad9ff35f23c55965934ac8913 100644 (file)
@@ -455,7 +455,7 @@ int gmx_x2top(int argc, char *argv[])
     t_symtab           symtab;
     real               qtot, mtot;
     char               n2t[STRLEN];
-    output_env_t       oenv;
+    gmx_output_env_t  *oenv;
 
     t_filenm           fnm[] = {
         { efSTX, "-f", "conf", ffREAD  },
index a3cd9be3067a5fbede1c47bba65f92a09bd6d823..1bffd8fe1c1c8d6d55ffe2d06d2f7be1d5f41de9 100644 (file)
@@ -1006,12 +1006,11 @@ static void imd_readcommand(t_gmx_IMD_setup *IMDsetup)
  *
  * Call on master only.
  */
-static FILE *open_imd_out(
-        const char           *fn,
-        t_gmx_IMD_setup      *IMDsetup,
-        int                   nat_total,
-        output_env_t          oenv,
-        unsigned long         Flags)
+static FILE *open_imd_out(const char             *fn,
+                          t_gmx_IMD_setup        *IMDsetup,
+                          int                     nat_total,
+                          const gmx_output_env_t *oenv,
+                          unsigned long           Flags)
 {
     FILE       *fp;
 
@@ -1314,17 +1313,17 @@ static void imd_check_integrator_parallel(t_inputrec *ir, t_commrec *cr)
     }
 }
 
-void init_IMD(t_inputrec    *ir,
-              t_commrec     *cr,
-              gmx_mtop_t    *top_global,
-              FILE          *fplog,
-              int            defnstimd,
-              rvec           x[],
-              int            nfile,
-              const t_filenm fnm[],
-              output_env_t   oenv,
-              int            imdport,
-              unsigned long  Flags)
+void init_IMD(t_inputrec             *ir,
+              t_commrec              *cr,
+              gmx_mtop_t             *top_global,
+              FILE                   *fplog,
+              int                     defnstimd,
+              rvec                    x[],
+              int                     nfile,
+              const t_filenm          fnm[],
+              const gmx_output_env_t *oenv,
+              int                     imdport,
+              unsigned long           Flags)
 {
     int              i;
     int              nat_total;
index 3c661445007e246ccabebef7eeedd58288a71007..d722247403c8970e09fab59b2ce31f867f7be832 100644 (file)
@@ -74,6 +74,7 @@
 struct gmx_domdec_t;
 struct gmx_enerdata_t;
 struct gmx_mtop_t;
+struct gmx_output_env_t;
 struct t_gmx_IMD;
 struct t_IMD;
 
@@ -133,7 +134,7 @@ void dd_make_local_IMD_atoms(gmx_bool bIMD, gmx_domdec_t *dd, t_IMD *imd);
  */
 void init_IMD(t_inputrec *ir, t_commrec *cr, gmx_mtop_t *top_global,
               FILE *fplog, int defnstimd, rvec x[],
-              int nfile, const t_filenm fnm[], output_env_t oenv,
+              int nfile, const t_filenm fnm[], const gmx_output_env_t *oenv,
               int imdport, unsigned long  Flags);
 
 
index d2ba8c2fd3a2a678aa41487ef961df37e3f674f4..a1242dde91e6a101cc2d9d1dd2ba75a8df86c889 100644 (file)
@@ -42,7 +42,6 @@
 /* DEPRECATED! value for signaling unitialized variables */
 #define NOTSET -12345
 
-#include "gromacs/legacyheaders/types/oenv.h"
 #include "gromacs/legacyheaders/types/simple.h"
 #include "gromacs/legacyheaders/types/state.h"
 #include "gromacs/topology/topology.h"
diff --git a/src/gromacs/legacyheaders/types/oenv.h b/src/gromacs/legacyheaders/types/oenv.h
deleted file mode 100644 (file)
index 1067720..0000000
+++ /dev/null
@@ -1,43 +0,0 @@
-/*
- * This file is part of the GROMACS molecular simulation package.
- *
- * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
- * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2012,2013,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.
- *
- * 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.
- */
-#ifndef GMX_TYPES_OENV_H
-#define GMX_TYPES_OENV_H
-
-/* output options opaque type, for functions in oenv.h */
-typedef struct gmx_output_env_t *output_env_t;
-
-#endif
index bd5ebf294016eaf40e798d75bec29dda23af2ef7..5e741eb4a0f7325094021f3f1dd9729459411640 100644 (file)
@@ -49,7 +49,6 @@
 #include "gromacs/legacyheaders/types/inputrec.h"
 #include "gromacs/legacyheaders/types/mdatom.h"
 #include "gromacs/legacyheaders/types/nrnb.h"
-#include "gromacs/legacyheaders/types/oenv.h"
 #include "gromacs/legacyheaders/types/state.h"
 #include "gromacs/mdlib/constr.h"
 #include "gromacs/timing/wallcycle.h"
@@ -60,6 +59,7 @@
 struct t_commrec;
 struct gmx_mtop_t;
 struct gmx_membed_t;
+struct gmx_output_env_t;
 
 namespace gmx
 {
@@ -97,7 +97,7 @@ namespace gmx
  */
 typedef double integrator_t (FILE *fplog, struct t_commrec *cr,
                              int nfile, const t_filenm fnm[],
-                             const output_env_t oenv, gmx_bool bVerbose,
+                             const gmx_output_env_t *oenv, gmx_bool bVerbose,
                              gmx_bool bCompact, int nstglobalcomm,
                              gmx_vsite_t *vsite, gmx_constr_t constr,
                              int stepout,
index 4d8c8a937907acdf6befa4f6d033d1eaacca2779..165cd3fa2ac183d9d8edcce3f0af230b78d188e9 100644 (file)
@@ -976,7 +976,7 @@ namespace gmx
 /*! \brief Do conjugate gradients minimization
     \copydoc integrator_t(FILE *fplog, t_commrec *cr,
                           int nfile, const t_filenm fnm[],
-                          const output_env_t oenv, gmx_bool bVerbose,
+                          const gmx_output_env_t *oenv, gmx_bool bVerbose,
                           gmx_bool bCompact, int nstglobalcomm,
                           gmx_vsite_t *vsite, gmx_constr_t constr,
                           int stepout,
@@ -996,7 +996,7 @@ namespace gmx
  */
 double do_cg(FILE *fplog, t_commrec *cr,
              int nfile, const t_filenm fnm[],
-             const output_env_t gmx_unused oenv, gmx_bool bVerbose, gmx_bool gmx_unused bCompact,
+             const gmx_output_env_t gmx_unused *oenv, gmx_bool bVerbose, gmx_bool gmx_unused bCompact,
              int gmx_unused nstglobalcomm,
              gmx_vsite_t *vsite, gmx_constr_t constr,
              int gmx_unused stepout,
@@ -1623,7 +1623,7 @@ double do_cg(FILE *fplog, t_commrec *cr,
 /*! \brief Do L-BFGS conjugate gradients minimization
     \copydoc integrator_t(FILE *fplog, t_commrec *cr,
                           int nfile, const t_filenm fnm[],
-                          const output_env_t oenv, gmx_bool bVerbose,
+                          const gmx_output_env_t *oenv, gmx_bool bVerbose,
                           gmx_bool bCompact, int nstglobalcomm,
                           gmx_vsite_t *vsite, gmx_constr_t constr,
                           int stepout,
@@ -1643,7 +1643,7 @@ double do_cg(FILE *fplog, t_commrec *cr,
  */
 double do_lbfgs(FILE *fplog, t_commrec *cr,
                 int nfile, const t_filenm fnm[],
-                const output_env_t gmx_unused oenv, gmx_bool bVerbose, gmx_bool gmx_unused bCompact,
+                const gmx_output_env_t gmx_unused *oenv, gmx_bool bVerbose, gmx_bool gmx_unused bCompact,
                 int gmx_unused nstglobalcomm,
                 gmx_vsite_t *vsite, gmx_constr_t constr,
                 int gmx_unused stepout,
@@ -2452,7 +2452,7 @@ double do_lbfgs(FILE *fplog, t_commrec *cr,
 /*! \brief Do steepest descents minimization
     \copydoc integrator_t(FILE *fplog, t_commrec *cr,
                           int nfile, const t_filenm fnm[],
-                          const output_env_t oenv, gmx_bool bVerbose,
+                          const gmx_output_env_t *oenv, gmx_bool bVerbose,
                           gmx_bool bCompact, int nstglobalcomm,
                           gmx_vsite_t *vsite, gmx_constr_t constr,
                           int stepout,
@@ -2472,7 +2472,7 @@ double do_lbfgs(FILE *fplog, t_commrec *cr,
  */
 double do_steep(FILE *fplog, t_commrec *cr,
                 int nfile, const t_filenm fnm[],
-                const output_env_t gmx_unused oenv, gmx_bool bVerbose, gmx_bool gmx_unused bCompact,
+                const gmx_output_env_t gmx_unused *oenv, gmx_bool bVerbose, gmx_bool gmx_unused bCompact,
                 int gmx_unused nstglobalcomm,
                 gmx_vsite_t *vsite, gmx_constr_t constr,
                 int gmx_unused stepout,
@@ -2711,7 +2711,7 @@ double do_steep(FILE *fplog, t_commrec *cr,
 /*! \brief Do normal modes analysis
     \copydoc integrator_t(FILE *fplog, t_commrec *cr,
                           int nfile, const t_filenm fnm[],
-                          const output_env_t oenv, gmx_bool bVerbose,
+                          const gmx_output_env_t *oenv, gmx_bool bVerbose,
                           gmx_bool bCompact, int nstglobalcomm,
                           gmx_vsite_t *vsite, gmx_constr_t constr,
                           int stepout,
@@ -2731,7 +2731,7 @@ double do_steep(FILE *fplog, t_commrec *cr,
  */
 double do_nm(FILE *fplog, t_commrec *cr,
              int nfile, const t_filenm fnm[],
-             const output_env_t gmx_unused oenv, gmx_bool bVerbose, gmx_bool gmx_unused  bCompact,
+             const gmx_output_env_t gmx_unused *oenv, gmx_bool bVerbose, gmx_bool gmx_unused  bCompact,
              int gmx_unused nstglobalcomm,
              gmx_vsite_t *vsite, gmx_constr_t constr,
              int gmx_unused stepout,
index e73af1f9127d4904f3d50eabaa75407087824abe..18cdb35be808aaa1bcb605a8c313ea8179731bab 100644 (file)
@@ -2739,7 +2739,7 @@ extern void initialize_lambdas(FILE *fplog, t_inputrec *ir, int *fep_state, real
 
 
 void init_md(FILE *fplog,
-             t_commrec *cr, t_inputrec *ir, const output_env_t oenv,
+             t_commrec *cr, t_inputrec *ir, const gmx_output_env_t *oenv,
              double *t, double *t0,
              real *lambda, int *fep_state, double *lam0,
              t_nrnb *nrnb, gmx_mtop_t *mtop,
index 8b06a73e78e6c86611504961fa354afab1657e90..113356c5dca36b6ca90f2fe38c0a5819bfc98020 100644 (file)
@@ -47,6 +47,7 @@
 #include "gromacs/timing/walltime_accounting.h"
 
 struct gmx_constr;
+struct gmx_output_env_t;
 struct nonbonded_verlet_t;
 struct t_graph;
 struct t_mdatoms;
@@ -126,7 +127,7 @@ void do_constrain_first(FILE *log, gmx_constr *constr,
                         t_forcerec *fr, gmx_localtop_t *top);
 
 void init_md(FILE *fplog,
-             t_commrec *cr, t_inputrec *ir, const output_env_t oenv,
+             t_commrec *cr, t_inputrec *ir, const gmx_output_env_t *oenv,
              double *t, double *t0,
              real *lambda, int *fep_state, double *lam0,
              t_nrnb *nrnb, gmx_mtop_t *mtop,
index 30fc43d36ba1d730b02e1c60754bae0095615d26..a8d665cc54ba720a4eb03473619ce7abff0925d1 100644 (file)
@@ -128,7 +128,7 @@ namespace gmx
 /*! \brief Do test particle insertion.
     \copydoc integrator_t (FILE *fplog, t_commrec *cr,
                            int nfile, const t_filenm fnm[],
-                           const output_env_t oenv, gmx_bool bVerbose,
+                           const gmx_output_env_t *oenv, gmx_bool bVerbose,
                            gmx_bool bCompact, int nstglobalcomm,
                            gmx_vsite_t *vsite, gmx_constr_t constr,
                            int stepout,
@@ -148,7 +148,7 @@ namespace gmx
  */
 double do_tpi(FILE *fplog, t_commrec *cr,
               int nfile, const t_filenm fnm[],
-              const output_env_t oenv, gmx_bool bVerbose, gmx_bool gmx_unused bCompact,
+              const gmx_output_env_t *oenv, gmx_bool bVerbose, gmx_bool gmx_unused bCompact,
               int gmx_unused nstglobalcomm,
               gmx_vsite_t gmx_unused *vsite, gmx_constr_t gmx_unused constr,
               int gmx_unused stepout,
index 13c2b54f5dc4bb2fcc21de4dd90875bcbd90a36a..3bf7dc6ad5dfa5f7946a63e802dc911965243be0 100644 (file)
@@ -186,7 +186,8 @@ void pull_print_output(struct pull_t *pull, gmx_int64_t step, double time)
     }
 }
 
-static FILE *open_pull_out(const char *fn, struct pull_t *pull, const output_env_t oenv,
+static FILE *open_pull_out(const char *fn, struct pull_t *pull,
+                           const gmx_output_env_t *oenv,
                            gmx_bool bCoord, unsigned long Flags)
 {
     FILE  *fp;
@@ -1636,7 +1637,8 @@ static void init_pull_group_index(FILE *fplog, t_commrec *cr,
 struct pull_t *
 init_pull(FILE *fplog, const pull_params_t *pull_params, const t_inputrec *ir,
           int nfile, const t_filenm fnm[],
-          gmx_mtop_t *mtop, t_commrec *cr, const output_env_t oenv, real lambda,
+          gmx_mtop_t *mtop, t_commrec *cr,
+          const gmx_output_env_t *oenv, real lambda,
           gmx_bool bOutFile, unsigned long Flags)
 {
     struct pull_t *pull;
index 8976dfaf4877e590a5d485852e6ce26a08613aae..e1cf63c0b674211519f730613a6f5c44c4d374d7 100644 (file)
@@ -57,6 +57,7 @@
 extern "C" {
 #endif
 
+struct gmx_output_env_t;
 struct pull_params_t;
 struct t_mdatoms;
 struct t_pbc;
@@ -174,17 +175,17 @@ void dd_make_local_pull_groups(t_commrec *cr,
  * \param Flags       Flags passed over from main, used to determine
  *                    whether or not we are appending.
  */
-struct pull_t *init_pull(FILE                *fplog,
-                         const pull_params_t *pull_params,
-                         const t_inputrec    *ir,
-                         int                  nfile,
-                         const t_filenm       fnm[],
-                         gmx_mtop_t          *mtop,
-                         t_commrec          * cr,
-                         const output_env_t   oenv,
-                         real                 lambda,
-                         gmx_bool             bOutFile,
-                         unsigned long        Flags);
+struct pull_t *init_pull(FILE                   *fplog,
+                         const pull_params_t    *pull_params,
+                         const t_inputrec       *ir,
+                         int                     nfile,
+                         const t_filenm          fnm[],
+                         gmx_mtop_t             *mtop,
+                         t_commrec             * cr,
+                         const gmx_output_env_t *oenv,
+                         real                    lambda,
+                         gmx_bool                bOutFile,
+                         unsigned long           Flags);
 
 
 /*! \brief Close the pull output files.
index 09a142f239a69628fd905ae78ec3f5fd298ccd81..350364c15415bc026a30547d845d9c61b8cf436d 100644 (file)
@@ -851,7 +851,7 @@ static void add_to_string_aligned(char **str, char *buf)
 
 /* Open output file and print some general information about the rotation groups.
  * Call on master only */
-static FILE *open_rot_out(const char *fn, t_rot *rot, const output_env_t oenv)
+static FILE *open_rot_out(const char *fn, t_rot *rot, const gmx_output_env_t *oenv)
 {
     FILE           *fp;
     int             g, nsets;
@@ -3666,7 +3666,7 @@ static int calc_mpi_bufsize(t_rot *rot)
 
 
 extern void init_rot(FILE *fplog, t_inputrec *ir, int nfile, const t_filenm fnm[],
-                     t_commrec *cr, rvec *x, matrix box, gmx_mtop_t *mtop, const output_env_t oenv,
+                     t_commrec *cr, rvec *x, matrix box, gmx_mtop_t *mtop, const gmx_output_env_t *oenv,
                      gmx_bool bVerbose, unsigned long Flags)
 {
     t_rot          *rot;
index b4a36e2d9b1fa5817942fe3222f59cc4ed52d195..770547c41a34838ceb154d208c7eb81f6f667303 100644 (file)
@@ -53,6 +53,7 @@
 #include "gromacs/timing/wallcycle.h"
 
 struct gmx_domdec_t;
+struct gmx_output_env_t;
 struct t_commrec;
 struct t_rot;
 
@@ -82,7 +83,7 @@ extern "C" {
  *                 whether or not we are doing a rerun.
  */
 extern void init_rot(FILE *fplog, t_inputrec *ir, int nfile, const t_filenm fnm[],
-                     struct t_commrec *cr, rvec *x, matrix box, gmx_mtop_t *mtop, const output_env_t oenv,
+                     struct t_commrec *cr, rvec *x, matrix box, gmx_mtop_t *mtop, const gmx_output_env_t *oenv,
                      gmx_bool bVerbose, unsigned long Flags);
 
 
index 59bcdca4636862789a47deee4ed1f3115b4740a9..a70aef4d6807726b3d966aa473a9b0e4cae5a16c 100644 (file)
@@ -1079,7 +1079,8 @@ static int get_group_apm_check(
  *
  * Also print the initial ion counts
  */
-static void print_ionlist_legend(t_inputrec *ir, const output_env_t oenv)
+static void print_ionlist_legend(t_inputrec             *ir,
+                                 const gmx_output_env_t *oenv)
 {
     const char **legend;
     int          ic, count, ii;
@@ -1340,18 +1341,17 @@ static void init_swapstate(
 }
 
 
-extern void init_swapcoords(
-        FILE              *fplog,
-        gmx_bool           bVerbose,
-        t_inputrec        *ir,
-        const char        *fn,
-        gmx_mtop_t        *mtop,
-        rvec               x[],
-        matrix             box,
-        swapstate_t       *swapstate,
-        t_commrec         *cr,
-        const output_env_t oenv,
-        unsigned long      Flags)
+void init_swapcoords(FILE                   *fplog,
+                     gmx_bool                bVerbose,
+                     t_inputrec             *ir,
+                     const char             *fn,
+                     gmx_mtop_t             *mtop,
+                     rvec                    x[],
+                     matrix                  box,
+                     swapstate_t            *swapstate,
+                     t_commrec              *cr,
+                     const gmx_output_env_t *oenv,
+                     unsigned long           Flags)
 {
     int                    i, ic, ig, ii, j;
     t_swapcoords          *sc;
@@ -1696,7 +1696,7 @@ extern void init_swapcoords(
 }
 
 
-extern void dd_make_local_swap_groups(gmx_domdec_t *dd, t_swapcoords *sc)
+void dd_make_local_swap_groups(gmx_domdec_t *dd, t_swapcoords *sc)
 {
     t_group *g;
     int      ig;
@@ -1832,17 +1832,16 @@ static void apply_modified_positions(
 }
 
 
-extern gmx_bool do_swapcoords(
-        t_commrec        *cr,
-        gmx_int64_t       step,
-        double            t,
-        t_inputrec       *ir,
-        gmx_wallcycle_t   wcycle,
-        rvec              x[],
-        matrix            box,
-        gmx_mtop_t       *mtop,
-        gmx_bool          bVerbose,
-        gmx_bool          bRerun)
+gmx_bool do_swapcoords(t_commrec        *cr,
+                       gmx_int64_t       step,
+                       double            t,
+                       t_inputrec       *ir,
+                       gmx_wallcycle_t   wcycle,
+                       rvec              x[],
+                       matrix            box,
+                       gmx_mtop_t       *mtop,
+                       gmx_bool          bVerbose,
+                       gmx_bool          bRerun)
 {
     t_swapcoords         *sc;
     t_swap               *s;
index 9afea69878a50284fa256870fb98bcd4236780b4..469e10f03f645511d1108bc0b8bed447c84e73e1 100644 (file)
@@ -56,6 +56,7 @@
 #include "gromacs/legacyheaders/types/commrec.h"
 #include "gromacs/timing/wallcycle.h"
 
+struct gmx_output_env_t;
 struct t_swapcoords;
 
 /*! \brief Initialize ion / water position swapping ("Computational Electrophysiology").
@@ -78,17 +79,17 @@ struct t_swapcoords;
  *                          whether we are doing a rerun, appending, etc.
  */
 void init_swapcoords(
-        FILE              *fplog,
-        gmx_bool           bVerbose,
-        t_inputrec        *ir,
-        const char        *fn,
-        gmx_mtop_t        *mtop,
-        rvec               x[],
-        matrix             box,
-        swapstate_t       *swapstate,
-        t_commrec         *cr,
-        const output_env_t oenv,
-        unsigned long      Flags);
+        FILE                   *fplog,
+        gmx_bool                bVerbose,
+        t_inputrec             *ir,
+        const char             *fn,
+        gmx_mtop_t             *mtop,
+        rvec                    x[],
+        matrix                  box,
+        swapstate_t            *swapstate,
+        t_commrec              *cr,
+        const gmx_output_env_t *oenv,
+        unsigned long           Flags);
 
 
 /*! \brief Make a selection of the home atoms for the swap groups. These are
index 7e58d7747e4f59d566476d613c483b99abba9ef8..12c686f29a891e034d330a462c3bc1f339cea24a 100644 (file)
@@ -274,7 +274,7 @@ static void chk_bonds(t_idef *idef, int ePBC, rvec *x, matrix box, real tol)
     }
 }
 
-void chk_trj(const output_env_t oenv, const char *fn, const char *tpr, real tol)
+void chk_trj(const gmx_output_env_t *oenv, const char *fn, const char *tpr, real tol)
 {
     t_trxframe       fr;
     t_count          count;
@@ -703,7 +703,7 @@ void chk_enx(const char *fn)
 
 int gmx_check(int argc, char *argv[])
 {
-    const char     *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] reads a trajectory ([REF].tng[ref], [REF].trr[ref] or ",
         "[REF].xtc[ref]), an energy file ([REF].edr[ref])",
         "or an index file ([REF].ndx[ref])",
@@ -731,7 +731,7 @@ int gmx_check(int argc, char *argv[])
         "In case the [TT]-m[tt] flag is given a LaTeX file will be written",
         "consisting of a rough outline for a methods section for a paper."
     };
-    t_filenm        fnm[] = {
+    t_filenm          fnm[] = {
         { efTRX, "-f",  NULL, ffOPTRD },
         { efTRX, "-f2",  NULL, ffOPTRD },
         { efTPR, "-s1", "top1", ffOPTRD },
@@ -743,18 +743,18 @@ int gmx_check(int argc, char *argv[])
         { efTEX, "-m",  NULL, ffOPTWR }
     };
 #define NFILE asize(fnm)
-    const char     *fn1 = NULL, *fn2 = NULL, *tex = NULL;
-
-    output_env_t    oenv;
-    static real     vdw_fac  = 0.8;
-    static real     bon_lo   = 0.4;
-    static real     bon_hi   = 0.7;
-    static gmx_bool bRMSD    = FALSE;
-    static real     ftol     = 0.001;
-    static real     abstol   = 0.001;
-    static gmx_bool bCompAB  = FALSE;
-    static char    *lastener = NULL;
-    static t_pargs  pa[]     = {
+    const char       *fn1 = NULL, *fn2 = NULL, *tex = NULL;
+
+    gmx_output_env_t *oenv;
+    static real       vdw_fac  = 0.8;
+    static real       bon_lo   = 0.4;
+    static real       bon_hi   = 0.7;
+    static gmx_bool   bRMSD    = FALSE;
+    static real       ftol     = 0.001;
+    static real       abstol   = 0.001;
+    static gmx_bool   bCompAB  = FALSE;
+    static char      *lastener = NULL;
+    static t_pargs    pa[]     = {
         { "-vdwfac", FALSE, etREAL, {&vdw_fac},
           "Fraction of sum of VdW radii used as warning cutoff" },
         { "-bonlo",  FALSE, etREAL, {&bon_lo},
index 2ede70dbe6a715f1d130f28b6f3a96d8d93ea846..b447896e104a077f9b9d400d4ce82e0732f49c90 100644 (file)
@@ -1079,7 +1079,7 @@ void comp_frame(FILE *fp, t_trxframe *fr1, t_trxframe *fr2,
     }
 }
 
-void comp_trx(const output_env_t oenv, const char *fn1, const char *fn2,
+void comp_trx(const gmx_output_env_t *oenv, const char *fn1, const char *fn2,
               gmx_bool bRMSD, real ftol, real abstol)
 {
     int          i;
index cf4f5470deda0eb427c39d3df45eafc41f831d9f..ee49c5e3162407414b0e36d3c3223e1cee1c1275 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.
@@ -38,6 +38,8 @@
 #ifndef GMX_TOOLS_COMPARE_H
 #define GMX_TOOLS_COMPARE_H
 
+struct gmx_output_env_t;
+
 /* Routines for comparing data structures from non-trajectory binary
    file formats (e.g. as used by gmx check). */
 
@@ -46,7 +48,7 @@ comp_tpx(const char *fn1, const char *fn2, gmx_bool bRMSD, real ftol, real absto
 /* Compare two binary run input files */
 
 void
-comp_trx(const output_env_t oenv, const char *fn1, const char *fn2,
+comp_trx(const gmx_output_env_t *oenv, const char *fn1, const char *fn2,
          gmx_bool bRMSD, real ftol, real abstol);
 /* Compare two binary trajectory files */
 
index 3854ff4e770abd91f3532edd67bba6a9ab931f61..370dc7b3b2c9decb78b6ae5de0983f6551f92835 100644 (file)
@@ -372,7 +372,7 @@ int gmx_convert_tpr(int argc, char *argv[])
     gmx_enxnm_t      *enm     = NULL;
     t_enxframe       *fr_ener = NULL;
     char              buf[200], buf2[200];
-    output_env_t      oenv;
+    gmx_output_env_t *oenv;
     t_filenm          fnm[] = {
         { efTPR, NULL,  NULL,    ffREAD  },
         { efTRN, "-f",  NULL,    ffOPTRD },
index 543b0a14af8841244c0c976fa06181dc50581abe..3869268755c821206535e069fb4186fec42d8af6 100644 (file)
@@ -609,11 +609,11 @@ int gmx_dump(int argc, char *argv[])
     };
 #define NFILE asize(fnm)
 
-    output_env_t    oenv;
+    gmx_output_env_t *oenv;
     /* Command line options */
-    static gmx_bool bShowNumbers = TRUE;
-    static gmx_bool bSysTop      = FALSE;
-    t_pargs         pa[]         = {
+    static gmx_bool   bShowNumbers = TRUE;
+    static gmx_bool   bSysTop      = FALSE;
+    t_pargs           pa[]         = {
         { "-nr", FALSE, etBOOL, {&bShowNumbers}, "Show index numbers in output (leaving them out makes comparison easier, but creates a useless topology)" },
         { "-sys", FALSE, etBOOL, {&bSysTop}, "List the atoms and bonded interactions for the whole system instead of for each molecule type" }
     };
index fafd52a40f92a092270c46dbd36256988fe803c3..89e57960ab4c377f78bf0f8a33d5ac816d648f4d 100644 (file)
@@ -78,7 +78,6 @@
 #include "gromacs/legacyheaders/types/interaction_const.h"
 #include "gromacs/legacyheaders/types/mdatom.h"
 #include "gromacs/legacyheaders/types/nrnb.h"
-#include "gromacs/legacyheaders/types/oenv.h"
 #include "gromacs/legacyheaders/types/state.h"
 #include "gromacs/listed-forces/manage-threading.h"
 #include "gromacs/math/utilities.h"
@@ -156,7 +155,7 @@ static void reset_all_counters(FILE *fplog, t_commrec *cr,
 /*! \libinternal
     \copydoc integrator_t (FILE *fplog, t_commrec *cr,
                            int nfile, const t_filenm fnm[],
-                           const output_env_t oenv, gmx_bool bVerbose,
+                           const gmx_output_env_t *oenv, gmx_bool bVerbose,
                            gmx_bool bCompact, int nstglobalcomm,
                            gmx_vsite_t *vsite, gmx_constr_t constr,
                            int stepout,
@@ -175,7 +174,7 @@ static void reset_all_counters(FILE *fplog, t_commrec *cr,
                            gmx_walltime_accounting_t walltime_accounting)
  */
 double gmx::do_md(FILE *fplog, t_commrec *cr, int nfile, const t_filenm fnm[],
-                  const output_env_t oenv, gmx_bool bVerbose, gmx_bool bCompact,
+                  const gmx_output_env_t *oenv, gmx_bool bVerbose, gmx_bool bCompact,
                   int nstglobalcomm,
                   gmx_vsite_t *vsite, gmx_constr_t constr,
                   int stepout, t_inputrec *ir,
index cd531f4f27e45d197400f4f8c811c73a419f3246..e6a8b7162fde53882dfcf222340ad8beaa1451fe 100644 (file)
@@ -266,46 +266,46 @@ int gmx_mdrun(int argc, char *argv[])
     const int     NFILE = asize(fnm);
 
     /* Command line options ! */
-    gmx_bool        bDDBondCheck  = TRUE;
-    gmx_bool        bDDBondComm   = TRUE;
-    gmx_bool        bTunePME      = TRUE;
-    gmx_bool        bVerbose      = FALSE;
-    gmx_bool        bCompact      = TRUE;
-    gmx_bool        bRerunVSite   = FALSE;
-    gmx_bool        bConfout      = TRUE;
-    gmx_bool        bReproducible = FALSE;
-    gmx_bool        bIMDwait      = FALSE;
-    gmx_bool        bIMDterm      = FALSE;
-    gmx_bool        bIMDpull      = FALSE;
+    gmx_bool          bDDBondCheck  = TRUE;
+    gmx_bool          bDDBondComm   = TRUE;
+    gmx_bool          bTunePME      = TRUE;
+    gmx_bool          bVerbose      = FALSE;
+    gmx_bool          bCompact      = TRUE;
+    gmx_bool          bRerunVSite   = FALSE;
+    gmx_bool          bConfout      = TRUE;
+    gmx_bool          bReproducible = FALSE;
+    gmx_bool          bIMDwait      = FALSE;
+    gmx_bool          bIMDterm      = FALSE;
+    gmx_bool          bIMDpull      = FALSE;
 
-    int             npme          = -1;
-    int             nstlist       = 0;
-    int             nmultisim     = 0;
-    int             nstglobalcomm = -1;
-    int             repl_ex_nst   = 0;
-    int             repl_ex_seed  = -1;
-    int             repl_ex_nex   = 0;
-    int             nstepout      = 100;
-    int             resetstep     = -1;
-    gmx_int64_t     nsteps        = -2;   /* the value -2 means that the mdp option will be used */
-    int             imdport       = 8888; /* can be almost anything, 8888 is easy to remember */
+    int               npme          = -1;
+    int               nstlist       = 0;
+    int               nmultisim     = 0;
+    int               nstglobalcomm = -1;
+    int               repl_ex_nst   = 0;
+    int               repl_ex_seed  = -1;
+    int               repl_ex_nex   = 0;
+    int               nstepout      = 100;
+    int               resetstep     = -1;
+    gmx_int64_t       nsteps        = -2;   /* the value -2 means that the mdp option will be used */
+    int               imdport       = 8888; /* can be almost anything, 8888 is easy to remember */
 
-    rvec            realddxyz          = {0, 0, 0};
-    const char     *ddno_opt[ddnoNR+1] =
+    rvec              realddxyz          = {0, 0, 0};
+    const char       *ddno_opt[ddnoNR+1] =
     { NULL, "interleave", "pp_pme", "cartesian", NULL };
-    const char     *dddlb_opt[] =
+    const char       *dddlb_opt[] =
     { NULL, "auto", "no", "yes", NULL };
-    const char     *thread_aff_opt[threadaffNR+1] =
+    const char       *thread_aff_opt[threadaffNR+1] =
     { NULL, "auto", "on", "off", NULL };
-    const char     *nbpu_opt[] =
+    const char       *nbpu_opt[] =
     { NULL, "auto", "cpu", "gpu", "gpu_cpu", NULL };
-    real            rdd                   = 0.0, rconstr = 0.0, dlb_scale = 0.8, pforce = -1;
-    char           *ddcsx                 = NULL, *ddcsy = NULL, *ddcsz = NULL;
-    real            cpt_period            = 15.0, max_hours = -1;
-    gmx_bool        bTryToAppendFiles     = TRUE;
-    gmx_bool        bKeepAndNumCPT        = FALSE;
-    gmx_bool        bResetCountersHalfWay = FALSE;
-    output_env_t    oenv                  = NULL;
+    real              rdd                   = 0.0, rconstr = 0.0, dlb_scale = 0.8, pforce = -1;
+    char             *ddcsx                 = NULL, *ddcsy = NULL, *ddcsz = NULL;
+    real              cpt_period            = 15.0, max_hours = -1;
+    gmx_bool          bTryToAppendFiles     = TRUE;
+    gmx_bool          bKeepAndNumCPT        = FALSE;
+    gmx_bool          bResetCountersHalfWay = FALSE;
+    gmx_output_env_t *oenv                  = NULL;
 
     /* Non transparent initialization of a complex gmx_hw_opt_t struct.
      * But unfortunately we are not allowed to call a function here,
index 3dc9752a95895205dd1333ad9c1e29c275565b52..c88ad73fcd2a1a171981af78b9ed6c9e7aa0f1d3 100644 (file)
@@ -129,38 +129,38 @@ tMPI_Thread_mutex_t deform_init_box_mutex = TMPI_THREAD_MUTEX_INITIALIZER;
 
 struct mdrunner_arglist
 {
-    gmx_hw_opt_t    hw_opt;
-    FILE           *fplog;
-    t_commrec      *cr;
-    int             nfile;
-    const t_filenm *fnm;
-    output_env_t    oenv;
-    gmx_bool        bVerbose;
-    gmx_bool        bCompact;
-    int             nstglobalcomm;
-    ivec            ddxyz;
-    int             dd_node_order;
-    real            rdd;
-    real            rconstr;
-    const char     *dddlb_opt;
-    real            dlb_scale;
-    const char     *ddcsx;
-    const char     *ddcsy;
-    const char     *ddcsz;
-    const char     *nbpu_opt;
-    int             nstlist_cmdline;
-    gmx_int64_t     nsteps_cmdline;
-    int             nstepout;
-    int             resetstep;
-    int             nmultisim;
-    int             repl_ex_nst;
-    int             repl_ex_nex;
-    int             repl_ex_seed;
-    real            pforce;
-    real            cpt_period;
-    real            max_hours;
-    int             imdport;
-    unsigned long   Flags;
+    gmx_hw_opt_t            hw_opt;
+    FILE                   *fplog;
+    t_commrec              *cr;
+    int                     nfile;
+    const t_filenm         *fnm;
+    const gmx_output_env_t *oenv;
+    gmx_bool                bVerbose;
+    gmx_bool                bCompact;
+    int                     nstglobalcomm;
+    ivec                    ddxyz;
+    int                     dd_node_order;
+    real                    rdd;
+    real                    rconstr;
+    const char             *dddlb_opt;
+    real                    dlb_scale;
+    const char             *ddcsx;
+    const char             *ddcsy;
+    const char             *ddcsz;
+    const char             *nbpu_opt;
+    int                     nstlist_cmdline;
+    gmx_int64_t             nsteps_cmdline;
+    int                     nstepout;
+    int                     resetstep;
+    int                     nmultisim;
+    int                     repl_ex_nst;
+    int                     repl_ex_nex;
+    int                     repl_ex_seed;
+    real                    pforce;
+    real                    cpt_period;
+    real                    max_hours;
+    int                     imdport;
+    unsigned long           Flags;
 };
 
 
@@ -204,7 +204,7 @@ static void mdrunner_start_fn(void *arg)
    All options besides nthreads are the same as for mdrunner(). */
 static t_commrec *mdrunner_start_threads(gmx_hw_opt_t *hw_opt,
                                          FILE *fplog, t_commrec *cr, int nfile,
-                                         const t_filenm fnm[], const output_env_t oenv, gmx_bool bVerbose,
+                                         const t_filenm fnm[], const gmx_output_env_t *oenv, gmx_bool bVerbose,
                                          gmx_bool bCompact, int nstglobalcomm,
                                          ivec ddxyz, int dd_node_order, real rdd, real rconstr,
                                          const char *dddlb_opt, real dlb_scale,
@@ -654,7 +654,7 @@ static integrator_t *my_integrator(unsigned int ei)
 
 int mdrunner(gmx_hw_opt_t *hw_opt,
              FILE *fplog, t_commrec *cr, int nfile,
-             const t_filenm fnm[], const output_env_t oenv, gmx_bool bVerbose,
+             const t_filenm fnm[], const gmx_output_env_t *oenv, gmx_bool bVerbose,
              gmx_bool bCompact, int nstglobalcomm,
              ivec ddxyz, int dd_node_order, real rdd, real rconstr,
              const char *dddlb_opt, real dlb_scale,
index 194dca4aeb6733bb2a007db09bf6d5430a43ea8f..b19d410a076acc106cf3c618554f9711d95ddf26 100644 (file)
 
 #include "gromacs/fileio/filenm.h"
 #include "gromacs/legacyheaders/types/hw_info.h"
-#include "gromacs/legacyheaders/types/oenv.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/utility/basedefinitions.h"
 #include "gromacs/utility/real.h"
 
+struct gmx_output_env_t;
 struct t_commrec;
 
 namespace gmx
@@ -95,7 +95,7 @@ namespace gmx
  */
 int mdrunner(gmx_hw_opt_t *hw_opt,
              FILE *fplog, struct t_commrec *cr, int nfile,
-             const t_filenm fnm[], const output_env_t oenv, gmx_bool bVerbose,
+             const t_filenm fnm[], const gmx_output_env_t *oenv, gmx_bool bVerbose,
              gmx_bool bCompact, int nstglobalcomm, ivec ddxyz, int dd_node_order,
              real rdd, real rconstr, const char *dddlb_opt, real dlb_scale,
              const char *ddcsx, const char *ddcsy, const char *ddcsz,
index acbf63f0f35722239cbff2edc5ce145997f94a46..5704cef1f6ede9151d13fd9ee2c67cfcf2e56591 100644 (file)
@@ -640,7 +640,7 @@ t_manager *init_man(t_x11 *x11, Window Parent,
                     int x, int y, int width, int height,
                     unsigned long fg, unsigned long bg,
                     int ePBC, matrix box,
-                    const output_env_t oenv)
+                    gmx_output_env_t *oenv)
 {
     t_manager *man;
 
index 1f48651beb59c018195d245213444f4b854b2b39..d765174d23089efb71a7a01d899eaa1b5d5bd1f0 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.
@@ -50,6 +50,8 @@
 #include "x11.h"
 #include "xutil.h"
 
+struct gmx_output_env_t;
+
 /* Some window sizes */
 #define EWIDTH      200
 #define EHEIGHT       0
@@ -105,50 +107,50 @@ typedef struct {
  *
  */
 typedef struct {
-    t_trxstatus   *status;
-    const char    *trajfile;
-    int            natom;    /* The number of atoms                    */
-    t_topology     top;      /* topology                             */
-    rvec           box_size;
-    real           time;     /* The actual time                      */
-    rvec          *x;        /* The coordinates                        */
-    iv2           *ix;       /* The coordinates after projection       */
-    real          *zz;       /* Z-coords                             */
-    matrix         box;      /* The box                                */
-    int            nobj;     /* The number of objects          */
-    t_object      *obj;      /* The objects on screen          */
-    bool          *bHydro;   /* true for hydrogen atoms                */
-    bool          *bLabel;   /* Show a label on atom i?              */
-    char         **szLab;    /* Array of pointers to labels          */
-    unsigned long *col;      /* The colour of the atoms                */
-    int           *size;     /* The size of the atoms          */
-    real          *vdw;      /* The VDWaals radius of the atoms        */
-    bool          *bVis;     /* visibility of atoms                  */
-    bool           bPbc;     /* Remove Periodic boundary             */
-    bool           bAnimate; /* Animation going on?                    */
-    bool           bEof;     /* End of file reached?                 */
-    bool           bStop;    /* Stopped by user?                     */
-    bool           bSort;    /* Sort the coordinates                   */
-    bool           bPlus;    /* Draw plus for single atom              */
-    int            nSkip;    /* Skip n steps after each frame  */
-    int            nWait;    /* Wait n ms after each frame           */
-    gmx_rmpbc_t    gpbc;     /* For removing peridiocity             */
-
-    t_windata      wd;       /* The manager subwindow                */
-    t_windata      title;    /* Title window                           */
-    t_3dview      *view;     /* The 3d struct                        */
-    t_molwin      *molw;     /* The molecule window                    */
-    t_butbox      *vbox;     /* The video box                  */
-    t_butbox      *bbox;     /* The button box                 */
-    t_legendwin   *legw;     /* The legend window                      */
-
-    output_env_t   oenv;     /* output env data */
+    t_trxstatus      *status;
+    const char       *trajfile;
+    int               natom;    /* The number of atoms                 */
+    t_topology        top;      /* topology                             */
+    rvec              box_size;
+    real              time;     /* The actual time                      */
+    rvec             *x;        /* The coordinates                     */
+    iv2              *ix;       /* The coordinates after projection    */
+    real             *zz;       /* Z-coords                             */
+    matrix            box;      /* The box                             */
+    int               nobj;     /* The number of objects               */
+    t_object         *obj;      /* The objects on screen               */
+    bool             *bHydro;   /* true for hydrogen atoms             */
+    bool             *bLabel;   /* Show a label on atom i?              */
+    char            **szLab;    /* Array of pointers to labels          */
+    unsigned long    *col;      /* The colour of the atoms             */
+    int              *size;     /* The size of the atoms               */
+    real             *vdw;      /* The VDWaals radius of the atoms     */
+    bool             *bVis;     /* visibility of atoms                  */
+    bool              bPbc;     /* Remove Periodic boundary             */
+    bool              bAnimate; /* Animation going on?                 */
+    bool              bEof;     /* End of file reached?                 */
+    bool              bStop;    /* Stopped by user?                     */
+    bool              bSort;    /* Sort the coordinates                        */
+    bool              bPlus;    /* Draw plus for single atom           */
+    int               nSkip;    /* Skip n steps after each frame       */
+    int               nWait;    /* Wait n ms after each frame           */
+    gmx_rmpbc_t       gpbc;     /* For removing peridiocity             */
+
+    t_windata         wd;       /* The manager subwindow                */
+    t_windata         title;    /* Title window                                */
+    t_3dview         *view;     /* The 3d struct                        */
+    t_molwin         *molw;     /* The molecule window                 */
+    t_butbox         *vbox;     /* The video box                       */
+    t_butbox         *bbox;     /* The button box                      */
+    t_legendwin      *legw;     /* The legend window                   */
+
+    gmx_output_env_t *oenv;     /* output env data */
 } t_manager;
 
 extern t_manager *init_man(t_x11 *x11, Window Parent,
                            int x, int y, int width, int height,
                            unsigned long fg, unsigned long bg,
-                           int ePBC, matrix box, const output_env_t oenv);
+                           int ePBC, matrix box, gmx_output_env_t *oenv);
 /* Initiate the display manager */
 
 extern void move_man(t_x11 *x11, t_manager *man, int width, int height);
index ec21d48dc6b61436534478951ece3699eba57f75..6174a73fda32cbd3508531922d86525efca9a6a5 100644 (file)
@@ -42,6 +42,7 @@
 
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/confio.h"
+#include "gromacs/fileio/oenv.h"
 #include "gromacs/fileio/tpxio.h"
 #include "gromacs/fileio/trx.h"
 #include "gromacs/legacyheaders/copyrite.h"
@@ -292,7 +293,7 @@ static const char *MenuTitle[MSIZE] = {
 };
 
 static void init_gmx(t_x11 *x11, char *program, int nfile, t_filenm fnm[],
-                     const output_env_t oenv)
+                     gmx_output_env_t *oenv)
 {
     Pixmap                pm;
     t_gmx                *gmx;
@@ -373,7 +374,7 @@ static void init_gmx(t_x11 *x11, char *program, int nfile, t_filenm fnm[],
 
 int gmx_view(int argc, char *argv[])
 {
-    const char  *desc[] = {
+    const char       *desc[] = {
         "[THISMODULE] is the GROMACS trajectory viewer. This program reads a",
         "trajectory file, a run input file and an index file and plots a",
         "3D structure of your molecule on your standard X Window",
@@ -389,13 +390,13 @@ int gmx_view(int argc, char *argv[])
         "Some of the more common X command line options can be used: ",
         "[TT]-bg[tt], [TT]-fg[tt] change colors, [TT]-font fontname[tt] changes the font."
     };
-    const char  *bugs[] = {
+    const char       *bugs[] = {
         "Balls option does not work",
         "Some times dumps core without a good reason"
     };
 
-    output_env_t oenv;
-    t_filenm     fnm[] = {
+    gmx_output_env_t *oenv;
+    t_filenm          fnm[] = {
         { efTRX, "-f", NULL, ffREAD },
         { efTPR, NULL, NULL, ffREAD },
         { efNDX, NULL, NULL, ffOPTRD }