Merge "Fix typo in Clang CFlags" into release-4-5-patches
authorDavid van der Spoel <davidvanderspoel@gmail.com>
Sun, 18 Mar 2012 11:30:31 +0000 (12:30 +0100)
committerGerrit Code Review <gerrit@gerrit.gromacs.org>
Sun, 18 Mar 2012 11:30:31 +0000 (12:30 +0100)
28 files changed:
share/html/online/mdp_opt.html
src/gmxlib/checkpoint.c
src/gmxlib/enxio.c
src/gmxlib/gmxfio.c
src/gmxlib/trajana/trajana.c
src/gmxlib/trnio.c
src/gmxlib/wman.c
src/kernel/gmxcheck.c
src/kernel/md.c
src/kernel/md_openmm.c
src/kernel/mdrun.c
src/mdlib/constr.c
src/mdlib/ebin.c
src/mdlib/stat.c
src/tools/gmx_analyze.c
src/tools/gmx_chi.c
src/tools/gmx_cluster.c
src/tools/gmx_density.c
src/tools/gmx_dipoles.c
src/tools/gmx_enemat.c
src/tools/gmx_energy.c
src/tools/gmx_kinetics.c
src/tools/gmx_mdmat.c
src/tools/gmx_membed.c
src/tools/gmx_rmsdist.c
src/tools/gmx_sorient.c
src/tools/gmx_tune_pme.c
src/tools/mk_angndx.c

index 84c6bf37b8d22d82c89d2a2fcbcade7d0a2bf628..74863725fe33b31db0d7c037177fa1928b96f3a8 100644 (file)
@@ -1466,7 +1466,8 @@ which dimension the freezing applies.
 To avoid spurious contibrutions to the virial and pressure due to large
 forces between completely frozen atoms you need to use
 <A HREF="#egexcl">energy group exclusions</A>, this also saves computing time.
-Note that frozen coordinates are not subject to pressure scaling.</dd>
+Note that coordinates of frozen atoms are not scaled by pressure-coupling
+algorithms.</dd>
 <dt><b>freezedim: </b></dt>
 <dd>dimensions for which groups in <b>freezegrps</b> should be frozen, 
 specify <tt>Y</tt> or <tt>N</tt> for X, Y and Z and for each group
index b29034741ff81fe655ad6c035a722f1c0b0f8930..0fd4973d7bdb38c4023235d4a04fe4eb9255c561 100644 (file)
@@ -164,7 +164,7 @@ static void cp_warning(FILE *fp)
 
 static void cp_error()
 {
-    gmx_fatal(FARGS,"Checkpoint file corrupted/truncated, or maybe you are out of quota?");
+    gmx_fatal(FARGS,"Checkpoint file corrupted/truncated, or maybe you are out of disk space?");
 }
 
 static void do_cpt_string_err(XDR *xd,gmx_bool bRead,const char *desc,char **s,FILE *list)
@@ -711,7 +711,7 @@ static void do_cpt_header(XDR *xd,gmx_bool bRead,int *file_version,
     res = xdr_int(xd,&magic);
     if (res == 0)
     {
-        gmx_fatal(FARGS,"The checkpoint file is empty/corrupted, or maybe you are out of quota?");
+        gmx_fatal(FARGS,"The checkpoint file is empty/corrupted, or maybe you are out of disk space?");
     }
     if (magic != CPT_MAGIC1)
     {
@@ -1264,7 +1264,7 @@ void write_checkpoint(const char *fn,gmx_bool bNumberAndKeep,
        (do_cpt_files(gmx_fio_getxdr(fp),FALSE,&outputfiles,&noutputfiles,NULL,
                      file_version) < 0))
     {
-        gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of quota?");
+        gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of disk space?");
     }
 
     do_cpt_footer(gmx_fio_getxdr(fp),FALSE,file_version);
@@ -1279,7 +1279,7 @@ void write_checkpoint(const char *fn,gmx_bool bNumberAndKeep,
     {
         char buf[STRLEN];
         sprintf(buf,
-                "Cannot fsync '%s'; maybe you are out of disk space or quota?",
+                "Cannot fsync '%s'; maybe you are out of disk space?",
                 gmx_fio_getname(ret));
 
         if (getenv(GMX_IGNORE_FSYNC_FAILURE_ENV)==NULL)
@@ -1294,7 +1294,7 @@ void write_checkpoint(const char *fn,gmx_bool bNumberAndKeep,
 
     if( gmx_fio_close(fp) != 0)
     {
-        gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of quota?");
+        gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of disk space?");
     }
 
     /* we don't move the checkpoint if the user specified they didn't want it,
@@ -1324,7 +1324,7 @@ void write_checkpoint(const char *fn,gmx_bool bNumberAndKeep,
         }
         if (gmx_file_rename(fntemp, fn) != 0)
         {
-            gmx_file("Cannot rename checkpoint file; maybe you are out of quota?");
+            gmx_file("Cannot rename checkpoint file; maybe you are out of disk space?");
         }
     }
 
@@ -1701,7 +1701,7 @@ static void read_checkpoint(const char *fn,FILE **pfplog,
     }
     if( gmx_fio_close(fp) != 0)
        {
-               gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of quota?");
+        gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of disk space?");
        }
     
     sfree(fprog);
@@ -1940,7 +1940,7 @@ read_checkpoint_state(const char *fn,int *simulation_part,
     read_checkpoint_data(fp,simulation_part,step,t,state,FALSE,NULL,NULL);
     if( gmx_fio_close(fp) != 0)
        {
-               gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of quota?");
+        gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of disk space?");
        }
 }
 
@@ -2041,7 +2041,7 @@ void list_checkpoint(const char *fn,FILE *out)
     }
     if( gmx_fio_close(fp) != 0)
        {
-               gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of quota?");
+        gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of disk space?");
        }
     
     done_state(&state);
@@ -2097,7 +2097,7 @@ gmx_bool read_checkpoint_simulation_part(const char *filename, int *simulation_p
                                  &nfiles,&outputfiles);
             if( gmx_fio_close(fp) != 0)
             {
-                gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of quota?");
+                gmx_file("Cannot read/write checkpoint; corrupt file, or maybe you are out of disk space?");
             }
             done_state(&state);
 
index 5c3266840c07f8dce69b3faf3f9f2c01860c4aaf..da55493f8617e3336af31cbc4db0fdfcc73e3ea4 100644 (file)
@@ -356,13 +356,13 @@ static void edr_strings(XDR *xdr,gmx_bool bRead,int file_version,
         }
         if(!xdr_string(xdr,&(nm->name),STRLEN))
         {
-            gmx_file("Cannot write energy names to file; maybe you are out of quota?");
+            gmx_file("Cannot write energy names to file; maybe you are out of disk space?");
         }
         if (file_version >= 2)
         {
             if(!xdr_string(xdr,&(nm->unit),STRLEN))
             {
-                gmx_file("Cannot write energy names to file; maybe you are out of quota?");
+                gmx_file("Cannot write energy names to file; maybe you are out of disk space?");
             }
         }
         else
@@ -399,7 +399,7 @@ void do_enxnms(ener_file_t ef,int *nre,gmx_enxnm_t **nms)
     {
         if(!bRead)
         {
-            gmx_file("Cannot write energy names to file; maybe you are out of quota?");
+            gmx_file("Cannot write energy names to file; maybe you are out of disk space?");
         }
         *nre=0;
         return;
@@ -698,7 +698,7 @@ void close_enx(ener_file_t ef)
 {
     if(gmx_fio_close(ef->fio) != 0)
     {
-        gmx_file("Cannot close energy file; it might be corrupt, or maybe you are out of quota?");  
+        gmx_file("Cannot close energy file; it might be corrupt, or maybe you are out of disk space?");
     }
 }
 
@@ -758,7 +758,7 @@ ener_file_t open_enx(const char *fn,const char *mode)
             do_eheader(ef,&file_version,fr,nre,&bWrongPrecision,&bOK);
             if(!bOK)
             {
-                gmx_file("Cannot write energy file header; maybe you are out of quota?");
+                gmx_file("Cannot write energy file header; maybe you are out of disk space?");
             }
 
             if (((fr->e_size && (fr->nre == nre) && 
@@ -888,7 +888,7 @@ gmx_bool do_enx(ener_file_t ef,t_enxframe *fr)
         }
         else
         {
-            gmx_file("Cannot write energy file header; maybe you are out of quota?");
+            gmx_file("Cannot write energy file header; maybe you are out of disk space?");
         }
         return FALSE;
     }
@@ -1017,7 +1017,7 @@ gmx_bool do_enx(ener_file_t ef,t_enxframe *fr)
     {
         if( gmx_fio_flush(ef->fio) != 0)
         {
-            gmx_file("Cannot write energy file; maybe you are out of quota?");
+            gmx_file("Cannot write energy file; maybe you are out of disk space?");
         }
     }
     
index d80d864d436b5892511e8a77ec3bade74fc53191..8487067b445749849c2b160874904b46e8a38505 100644 (file)
@@ -788,7 +788,7 @@ static int gmx_fio_int_get_file_position(t_fileio *fio, gmx_off_t *offset)
         char buf[STRLEN];
         sprintf(
             buf,
-            "Cannot write file '%s'; maybe you are out of disk space or quota?",
+            "Cannot write file '%s'; maybe you are out of disk space?",
             fio->fn);
         gmx_file(buf);
     }
index 4dde161ca7f584fd097c7587621dae86b933bdf7..91b79be4ec79e8936d45e684e704594a5e745a21 100644 (file)
@@ -711,7 +711,11 @@ parse_trjana_args(gmx_ana_traj_t *d,
     gmx_bool                bSelDump  = FALSE;
     t_pargs             sel_pa[] = {
         {"-select",   FALSE, etSTR,  {&selection},
-         "Selection string (use 'help' for help)"},
+         "Selection string (use 'help' for help). Note that the "
+         "whole selection string will need to be quoted so that "
+         "your shell will pass it in as a string. Example: "
+         "[TT]g_select -select '\"Nearby water\" resname SOL "
+         "and within 0.25 of group Protein'[tt]"},
         {"-seldebug", FALSE, etBOOL, {&bSelDump},
          "HIDDENPrint out the parsed and compiled selection trees"},
     };
index ea72d36f706241b90a6ad5c76b7ed6c0b3574b7a..3cc7ef1d470f2115f792a21a50ab4d2b201dd928 100644 (file)
@@ -250,7 +250,7 @@ void fwrite_trn(t_fileio *fio,int step,real t,real lambda,
 {
   if( do_trn(fio,FALSE,&step,&t,&lambda,box,&natoms,x,v,f) == FALSE)
   {
-      gmx_file("Cannot write trajectory frame; maybe you are out of quota?");
+      gmx_file("Cannot write trajectory frame; maybe you are out of disk space?");
   }
 }
 
index 78ea86bf236955dc1fe86fea614b00cfd2e61c5c..13e77c559071f64d5661fc0529d0fa242bab12e3 100644 (file)
@@ -101,6 +101,10 @@ const t_sandr_const sandrTeX[] = {
   { "[grk]", "}" },
   { "[MATH]","\\ensuremath{" },
   { "[math]","}" },
+  { "[CHEVRON]", "\\ensuremath{<}" },
+  { "[chevron]", "\\ensuremath{>}" },
+  { "[MAG]", "\\ensuremath{|}" },
+  { "[mag]", "\\ensuremath{|}" },
   { "[INT]","\\ensuremath{\\int" },
   { "[FROM]","_" },
   { "[from]","" },
@@ -130,13 +134,7 @@ const t_sandr_const sandrTeX[] = {
   { "[SINH]","\\ensuremath{\\sinh{(" },
   { "[sinh]",")}}" },
   { "[TANH]","\\ensuremath{\\tanh{(" },
-  { "[tanh]",")}}" },
-  /* The next two lines used to substitute "|" and "||" to "or", but only
-   * g_angle used that functionality, so that was changed to a textual
-   * "or" there, so that other places could use those symbols to indicate
-   * magnitudes. */
-  { "||",    "\\textbar{}\\textbar"    },
-  { "|",     "\\textbar{}"    }
+  { "[tanh]",")}}" }
 };
 #define NSRTEX asize(sandrTeX)
 
@@ -149,6 +147,10 @@ const t_sandr_const sandrTty[] = {
   { "[it]", "" },
   { "[MATH]","" },
   { "[math]","" },
+  { "[CHEVRON]","<" },
+  { "[chevron]",">" },
+  { "[MAG]", "|" },
+  { "[mag]", "|" },
   { "[INT]","integral" },
   { "[FROM]"," from " },
   { "[from]","" },
@@ -198,6 +200,10 @@ const t_sandr_const sandrWiki[] = {
   { "[it]", "''" },
   { "[MATH]","" },
   { "[math]","" },
+  { "[CHEVRON]","<" },
+  { "[chevron]",">" },
+  { "[MAG]", "|" },
+  { "[mag]", "|" },
   { "[INT]","integral" },
   { "[FROM]"," from " },
   { "[from]","" },
@@ -244,6 +250,10 @@ const t_sandr_const sandrNROFF[] = {
   { "[it]", "\\fR" },
   { "[MATH]","" },
   { "[math]","" },
+  { "[CHEVRON]","<" },
+  { "[chevron]",">" },
+  { "[MAG]", "|" },
+  { "[mag]", "|" },
   { "[INT]","integral" },
   { "[FROM]"," from " },
   { "[from]","" },
@@ -298,6 +308,10 @@ const t_sandr_const sandrHTML[] = {
   { "[it]", "</it>" },
   { "[MATH]","" },
   { "[math]","" },
+  { "[CHEVRON]","<" },
+  { "[chevron]",">" },
+  { "[MAG]", "|" },
+  { "[mag]", "|" },
   { "[INT]","integral" },
   { "[FROM]"," from " },
   { "[from]","" },
@@ -346,6 +360,10 @@ const t_sandr_const sandrXML[] = {
   { "[it]", "</it>" },
   { "[MATH]","" },
   { "[math]","" },
+  { "[CHEVRON]","<" },
+  { "[chevron]",">" },
+  { "[MAG]", "|" },
+  { "[mag]", "|" },
   { "[INT]","integral" },
   { "[FROM]"," from " },
   { "[from]","" },
index f3efce54f1050f6e27015cba4206bd84339536ac..141a7f3e55d8503e43c6d844523b72f6c966b1ac 100644 (file)
@@ -654,7 +654,7 @@ int main(int argc,char *argv[])
     { "-rmsd",   FALSE, etBOOL, {&bRMSD},
       "Print RMSD for x, v and f" },
     { "-tol",    FALSE, etREAL, {&ftol},
-      "Relative tolerance for comparing real values defined as 2*(a-b)/(|a|+|b|)" },
+      "Relative tolerance for comparing real values defined as [MATH]2*(a-b)/([MAG]a[mag]+[MAG]b[mag])[math]" },
     { "-abstol",    FALSE, etREAL, {&abstol},
       "Absolute tolerance, useful when sums are close to zero." },
     { "-ab",     FALSE, etBOOL, {&bCompAB},
index 0ca2dc97a077c21174f505830ec60071c83b38e9..67e51a7a0d415f0f09d363c67e57dc1ebebf68bf 100644 (file)
@@ -1728,7 +1728,7 @@ double do_md(FILE *fplog,t_commrec *cr,int nfile,const t_filenm fnm[],
             {
                 if(fflush(fplog) != 0)
                 {
-                    gmx_fatal(FARGS,"Cannot flush logfile - maybe you are out of quota?");
+                    gmx_fatal(FARGS,"Cannot flush logfile - maybe you are out of disk space?");
                 }
             }
         }
index 8adad4d4458fb941f5ca1c3e933a937ff207bd22..564d5138eceda8480c5b8a9552288cc911146130 100644 (file)
@@ -539,7 +539,7 @@ double do_md_openmm(FILE *fplog,t_commrec *cr,int nfile,const t_filenm fnm[],
         {
             if (fflush(fplog) != 0)
             {
-                gmx_fatal(FARGS,"Cannot flush logfile - maybe you are out of quota?");
+                gmx_fatal(FARGS,"Cannot flush logfile - maybe you are out of disk space?");
             }
         }
 
index 3804c5cfcba3f7a1885ae2e8e73e7c9d0eb71c48..085e35020fb3d2e86e5878ed770def40bea88a13 100644 (file)
@@ -474,7 +474,7 @@ int main(int argc,char *argv[])
     { "-multi",   FALSE, etINT,{&nmultisim}, 
       "Do multiple simulations in parallel" },
     { "-replex",  FALSE, etINT, {&repl_ex_nst}, 
-      "Attempt replica exchange periodically with this period" },
+      "Attempt replica exchange periodically with this period (steps)" },
     { "-reseed",  FALSE, etINT, {&repl_ex_seed}, 
       "Seed for replica exchange, -1 is generate a seed" },
     { "-rerunvsite", FALSE, etBOOL, {&bRerunVSite},
index 815076e60f91221c8f6c10fa9fdefe2a84e64eac..94abc70af7d517fe6330ee33dcf85caa4c5d86a5 100644 (file)
@@ -773,8 +773,6 @@ void set_constraints(struct gmx_constr *constr,
                 constr->lagr_nalloc = over_alloc_dd(ncons);
                 srenew(constr->lagr,constr->lagr_nalloc);
             }
-
-            constr->shaked = shake_init();
         }
     }
 
@@ -1035,6 +1033,8 @@ gmx_constr_t init_constraints(FILE *fplog,
             {
                 please_cite(fplog,"Barth95a");
             }
+
+            constr->shaked = shake_init();
         }
     }
   
index 89740bcb51634ddc4e0966b6e09eaaf0f4044384..f4163a0c29044b945abdf1d5c4152333b0d1d0ad 100644 (file)
@@ -259,7 +259,7 @@ void pr_ebin(FILE *fp,t_ebin *eb,int index,int nener,int nperline,
     }
     if (rc < 0)
     { 
-        gmx_fatal(FARGS,"Cannot write to logfile; maybe you are out of quota?");
+        gmx_fatal(FARGS,"Cannot write to logfile; maybe you are out of disk space?");
     }
 }
 
index ddf1d3b188fca4430d56e74889b965672e70daa9..185b15cb6b81d7c62436c9d34f39df985d347229 100644 (file)
@@ -662,7 +662,7 @@ void write_traj(FILE *fplog,t_commrec *cr,
                        (mdof_flags & MDOF_F) ? f_global : NULL);
             if (gmx_fio_flush(of->fp_trn) != 0)
             {
-                gmx_file("Cannot write trajectory; maybe you are out of quota?");
+                gmx_file("Cannot write trajectory; maybe you are out of disk space?");
             }
             gmx_fio_check_file_position(of->fp_trn);
         }      
@@ -702,7 +702,7 @@ void write_traj(FILE *fplog,t_commrec *cr,
             if (write_xtc(of->fp_xtc,*n_xtc,step,t,
                           state_local->box,xxtc,of->xtc_prec) == 0)
             {
-                gmx_fatal(FARGS,"XTC error - maybe you are out of quota?");
+                gmx_fatal(FARGS,"XTC error - maybe you are out of disk space?");
             }
             gmx_fio_check_file_position(of->fp_xtc);
         }
index d050de5a342e5489920a422866ce6be3d9d6b63b..7b7da628f82a7a6b5d0dd57d6a666c0edc2ba633 100644 (file)
@@ -932,7 +932,7 @@ int gmx_analyze(int argc,char *argv[])
     "A set is divided in a number of blocks and averages are calculated for",
     "each block. The error for the total average is calculated from",
     "the variance between averages of the m blocks B[SUB]i[sub] as follows:",
-    "error^2 = [SUM][sum] (B[SUB]i[sub] - <B>)^2 / (m*(m-1)).",
+    "error^2 = [SUM][sum] (B[SUB]i[sub] - [CHEVRON]B[chevron])^2 / (m*(m-1)).",
     "These errors are plotted as a function of the block size.",
     "Also an analytical block average curve is plotted, assuming",
     "that the autocorrelation is a sum of two exponentials.",
index f6378c5109fc46b464ef6fc6d441f0cb8d79121a..97f58ad4f6c910fa478ccd94a81f8fb17b804f3c 100644 (file)
@@ -1013,7 +1013,7 @@ int gmx_chi(int argc,char *argv[])
     "The distributions [TT](histo-(dihedral)(RESIDUE).xvg[tt]) are cumulative over all residues of each type.[PAR]", 
     "If option [TT]-corr[tt] is given, the program will",
     "calculate dihedral autocorrelation functions. The function used",
-    "is C(t) = < [COS][GRK]chi[grk]([GRK]tau[grk])[cos] [COS][GRK]chi[grk]([GRK]tau[grk]+t)[cos] >. The use of cosines",
+    "is C(t) = [CHEVRON][COS][GRK]chi[grk]([GRK]tau[grk])[cos] [COS][GRK]chi[grk]([GRK]tau[grk]+t)[cos][chevron]. The use of cosines",
     "rather than angles themselves, resolves the problem of periodicity.",
     "(Van der Spoel & Berendsen (1997), Biophys. J. 72, 2032-2041).",
     "Separate files for each dihedral of each residue", 
index d5a8cf84677f33e496047d07db76f474f88223b0..75f42f21f312510f1b7301c91e4769d98c08ff39 100644 (file)
@@ -1060,7 +1060,7 @@ int gmx_cluster(int argc,char *argv[])
     { "-dista", FALSE, etBOOL, {&bRMSdist},
       "Use RMSD of distances instead of RMS deviation" },
     { "-nlevels",FALSE,etINT,  {&nlevels},
-      "Discretize RMSD matrix in # levels" },
+      "Discretize RMSD matrix in this number of levels" },
     { "-cutoff",FALSE, etREAL, {&rmsdcut},
       "RMSD cut-off (nm) for two structures to be neighbor" },
     { "-fit",   FALSE, etBOOL, {&bFit},
@@ -1072,9 +1072,9 @@ int gmx_cluster(int argc,char *argv[])
     { "-av",    FALSE, etBOOL, {&bAverage},
       "Write average iso middle structure for each cluster" },
     { "-wcl",   FALSE, etINT,  {&write_ncl},
-      "Write all structures for first # clusters to numbered files" },
+      "Write the structures for this number of clusters to numbered files" },
     { "-nst",   FALSE, etINT,  {&write_nst},
-      "Only write all structures if more than # per cluster" },
+      "Only write all structures if more than this number of structures per cluster" },
     { "-rmsmin",FALSE, etREAL, {&rmsmin},
       "minimum rms difference with rest of cluster for writing structures" },
     { "-method",FALSE, etENUM, {methodname},
index 9d64e7b839fe3311efc9d353be2048715d9e125f..fa02130d96efa238c5ecf85c757384d8dbdba6db 100644 (file)
@@ -394,11 +394,11 @@ int gmx_density(int argc,char *argv[])
     { "-d", FALSE, etSTR, {&axtitle}, 
       "Take the normal on the membrane in direction X, Y or Z." },
     { "-sl",  FALSE, etINT, {&nslices},
-      "Divide the box in #nr slices." },
+      "Divide the box in this number of slices." },
     { "-dens",    FALSE, etENUM, {dens_opt},
       "Density"},
     { "-ng",       FALSE, etINT, {&ngrps},
-      "Number of groups to compute densities of" },
+      "Number of groups of which to compute densities." },
     { "-symm",    FALSE, etBOOL, {&bSymmetrize},
       "Symmetrize the density along the axis, with respect to the center. Useful for bilayers." },
     { "-center",  FALSE, etBOOL, {&bCenter},
index 7d04c85d2d14a22d4acc847baf83482c0e8e076d..d7cd26ed095a2a78cb3e7e10b582bbfc654751e1 100644 (file)
@@ -1273,7 +1273,7 @@ int gmx_dipoles(int argc,char *argv[])
         "center of mass of the molecule.[PAR]",
         "The file [TT]Mtot.xvg[tt] contains the total dipole moment of a frame, the",
         "components as well as the norm of the vector.",
-        "The file [TT]aver.xvg[tt] contains < |[GRK]mu[grk]|^2 > and |< [GRK]mu[grk] >|^2 during the",
+        "The file [TT]aver.xvg[tt] contains [CHEVRON][MAG][GRK]mu[grk][mag]^2[chevron] and [MAG][CHEVRON][GRK]mu[grk][chevron][mag]^2 during the",
         "simulation.",
         "The file [TT]dipdist.xvg[tt] contains the distribution of dipole moments during",
         "the simulation",
@@ -1325,13 +1325,13 @@ int gmx_dipoles(int argc,char *argv[])
         { "-corr",     FALSE, etENUM, {corrtype},
           "Correlation function to calculate" },
         { "-pairs",    FALSE, etBOOL, {&bPairs},
-          "Calculate |cos [GRK]theta[grk]| between all pairs of molecules. May be slow" },
+          "Calculate [MAG][COS][GRK]theta[grk][cos][mag] between all pairs of molecules. May be slow" },
         { "-ncos",     FALSE, etINT, {&ncos},
-          "Must be 1 or 2. Determines whether the <cos> is computed between all molecules in one group, or between molecules in two different groups. This turns on the [TT]-gkr[tt] flag." }, 
+          "Must be 1 or 2. Determines whether the [CHEVRON][COS][GRK]theta[grk][cos][chevron] is computed between all molecules in one group, or between molecules in two different groups. This turns on the [TT]-g[tt] flag." },
         { "-axis",     FALSE, etSTR, {&axtitle}, 
           "Take the normal on the computational box in direction X, Y or Z." },
         { "-sl",       FALSE, etINT, {&nslices},
-          "Divide the box in #nr slices." },
+          "Divide the box into this number of slices." },
         { "-gkratom",  FALSE, etINT, {&nFA},
           "Use the n-th atom of a molecule (starting from 1) to calculate the distance between molecules rather than the center of charge (when 0) in the calculation of distance dependent Kirkwood factors" },
         { "-gkratom2", FALSE, etINT, {&nFB},
index 9498abc8632d8f71044451547dfdeadd74598551..a1a4780dbaee606a877fea83762be7ae0e2e5b43 100644 (file)
@@ -95,7 +95,7 @@ int gmx_enemat(int argc,char *argv[])
     "calculated ([TT]-etot[tt]).[PAR]",
     
     "An approximation of the free energy can be calculated using:",
-    "[MATH]E[SUB]free[sub] = E[SUB]0[sub] + kT [LOG]<[EXP](E-E[SUB]0[sub])/kT[exp]>[log][math], where '<>'",
+    "[MATH]E[SUB]free[sub] = E[SUB]0[sub] + kT [LOG][CHEVRON][EXP](E-E[SUB]0[sub])/kT[exp][chevron][log][math], where '[MATH][CHEVRON][chevron][math]'",
     "stands for time-average. A file with reference free energies",
     "can be supplied to calculate the free energy difference",
     "with some reference state. Group names (e.g. residue names)",
index be7ef3f4e45bb36e5acbbec9122856cf986be877..4fd8f98a0624bc2517c66bbd51e90acec9b00605 100644 (file)
@@ -1703,20 +1703,20 @@ int gmx_energy(int argc,char *argv[])
 
     "With [TT]-fee[tt] an estimate is calculated for the free-energy",
     "difference with an ideal gas state: [BR]",
-    "  [GRK]Delta[grk] A = A(N,V,T) - A[SUB]idealgas[sub](N,V,T) = kT [LN] < [EXP]U[SUB]pot[sub]/kT[exp] >[ln][BR]",
-    "  [GRK]Delta[grk] G = G(N,p,T) - G[SUB]idealgas[sub](N,p,T) = kT [LN] < [EXP]U[SUB]pot[sub]/kT[exp] >[ln][BR]",
+    "  [GRK]Delta[grk] A = A(N,V,T) - A[SUB]idealgas[sub](N,V,T) = kT [LN][CHEVRON][EXP]U[SUB]pot[sub]/kT[exp][chevron][ln][BR]",
+    "  [GRK]Delta[grk] G = G(N,p,T) - G[SUB]idealgas[sub](N,p,T) = kT [LN][CHEVRON][EXP]U[SUB]pot[sub]/kT[exp][chevron][ln][BR]",
     "where k is Boltzmann's constant, T is set by [TT]-fetemp[tt] and",
     "the average is over the ensemble (or time in a trajectory).",
     "Note that this is in principle",
     "only correct when averaging over the whole (Boltzmann) ensemble",
     "and using the potential energy. This also allows for an entropy",
     "estimate using:[BR]",
-    "  [GRK]Delta[grk] S(N,V,T) = S(N,V,T) - S[SUB]idealgas[sub](N,V,T) = (<U[SUB]pot[sub]> - [GRK]Delta[grk] A)/T[BR]",
-    "  [GRK]Delta[grk] S(N,p,T) = S(N,p,T) - S[SUB]idealgas[sub](N,p,T) = (<U[SUB]pot[sub]> + pV - [GRK]Delta[grk] G)/T",
+    "  [GRK]Delta[grk] S(N,V,T) = S(N,V,T) - S[SUB]idealgas[sub](N,V,T) = ([CHEVRON]U[SUB]pot[sub][chevron] - [GRK]Delta[grk] A)/T[BR]",
+    "  [GRK]Delta[grk] S(N,p,T) = S(N,p,T) - S[SUB]idealgas[sub](N,p,T) = ([CHEVRON]U[SUB]pot[sub][chevron] + pV - [GRK]Delta[grk] G)/T",
     "[PAR]",
     
     "When a second energy file is specified ([TT]-f2[tt]), a free energy",
-    "difference is calculated [BR] dF = -kT [LN]< [EXP]-(E[SUB]B[sub]-E[SUB]A[sub])/kT[exp] >[SUB]A[sub][ln] ,",
+    "difference is calculated [BR] dF = -kT [LN][CHEVRON][EXP]-(E[SUB]B[sub]-E[SUB]A[sub])/kT[exp][chevron][SUB]A[sub][ln] ,",
     "where E[SUB]A[sub] and E[SUB]B[sub] are the energies from the first and second energy",
     "files, and the average is over the ensemble A. The running average",
     "of the free energy difference is printed to a file specified by [TT]-ravg[tt].",
index f2c599ae381a56eef1e8911de993eaea875d2470..788780659d228accfa74e880026a0cb79461175b 100644 (file)
@@ -725,7 +725,7 @@ int gmx_kinetics(int argc,char *argv[])
     { "-T",       FALSE, etREAL, {&tref},
       "Reference temperature for computing rate constants" },
     { "-n",       FALSE, etINT, {&nreplica},
-      "Read data for # replicas. Only necessary when files are written in xmgrace format using @type and & as delimiters." },
+      "Read data for this number of replicas. Only necessary when files are written in xmgrace format using @type and & as delimiters." },
     { "-cut",     FALSE, etREAL, {&cutoff},
       "Cut-off (max) value for regarding a structure as folded" },
     { "-ucut",    FALSE, etREAL, {&ucut},
index 9530c4e8551d4d70ab8ba35a68408effa04068d4..5517e980d9774a2929fccad169d773ad7472dfaa 100644 (file)
@@ -168,7 +168,7 @@ int gmx_mdmat(int argc,char *argv[])
     { "-t",   FALSE, etREAL, {&truncate},
       "trunc distance" },
     { "-nlevels",   FALSE, etINT,  {&nlevels},
-      "Discretize distance in # levels" }
+      "Discretize distance in this number of levels" }
   };
   t_filenm   fnm[] = {
     { efTRX, "-f",  NULL, ffREAD },
index a290ec057b7cfd1b38b6dd16872a86549323fe08..91aeb2b7b761d146aaeaad1e3c8e7ff6c3fefc80 100644 (file)
@@ -2544,7 +2544,7 @@ double do_md_membed(FILE *fplog,t_commrec *cr,int nfile,const t_filenm fnm[],
             {
                 if(fflush(fplog) != 0)
                 {
-                    gmx_fatal(FARGS,"Cannot flush logfile - maybe you are out of quota?");
+                    gmx_fatal(FARGS,"Cannot flush logfile - maybe you are out of disk space?");
                 }
             }
         }
@@ -3608,7 +3608,7 @@ int gmx_membed(int argc,char *argv[])
   { "-multi",   FALSE, etINT,{&nmultisim},
     "HIDDENDo multiple simulations in parallel" },
   { "-replex",  FALSE, etINT, {&repl_ex_nst},
-    "HIDDENAttempt replica exchange every # steps" },
+    "HIDDENAttempt replica exchange periodically with this period (steps)" },
   { "-reseed",  FALSE, etINT, {&repl_ex_seed},
     "HIDDENSeed for replica exchange, -1 is generate a seed" },
   { "-rerunvsite", FALSE, etBOOL, {&bRerunVSite},
index 1f9a0b0d8a291ac0a838804463fc500b2d852031..a5597cc3aa564d0411c11b011c580f7afd300ad2 100644 (file)
@@ -564,11 +564,11 @@ int gmx_rmsdist (int argc,char *argv[])
 
   t_pargs pa[] = {
     { "-nlevels",   FALSE, etINT,  {&nlevels}, 
-      "Discretize rms in # levels" },
+      "Discretize RMS in this number of levels" },
     { "-max",   FALSE, etREAL, {&scalemax},    
       "Maximum level in matrices" },
     { "-sumh",  FALSE, etBOOL, {&bSumH},       
-      "average distance over equivalent hydrogens" },
+      "Average distance over equivalent hydrogens" },
     { "-pbc",   FALSE, etBOOL, {&bPBC},
       "Use periodic boundary conditions when computing distances" }
   };
index 213eb7f796cea5cd9122a7d766665efc44b9a031..8df2b4fcb8c0e8aba52fc250759ff33cfee0424a 100644 (file)
@@ -128,9 +128,9 @@ int gmx_sorient(int argc,char *argv[])
     "[TT]g_sorient[tt] 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:[PAR]",
-    "[GRK]theta[grk]1: the angle with the vector from the first atom of the solvent",
+    "[GRK]theta[grk][SUB]1[sub]: the angle with the vector from the first atom of the solvent",
     "molecule to the midpoint between atoms 2 and 3.[BR]",
-    "[GRK]theta[grk]2: the angle with the normal of the solvent plane, defined by the",
+    "[GRK]theta[grk][SUB]2[sub]: the angle with the normal of the solvent plane, defined by the",
     "same three atoms, or, when the option [TT]-v23[tt] is set, ",
     "the angle with the vector between atoms 2 and 3.[PAR]",
     "The reference can be a set of atoms or",
@@ -138,12 +138,12 @@ int gmx_sorient(int argc,char *argv[])
     "consist of 3 atoms per solvent molecule.",
     "Only solvent molecules between [TT]-rmin[tt] and [TT]-rmax[tt] are",
     "considered for [TT]-o[tt] and [TT]-no[tt] each frame.[PAR]",
-    "[TT]-o[tt]: distribtion of cos([GRK]theta[grk]1) for rmin<=r<=rmax.[PAR]",
-    "[TT]-no[tt]: distribution of cos([GRK]theta[grk]2) for rmin<=r<=rmax.[PAR]",
-    "[TT]-ro[tt]: <cos([GRK]theta[grk]1)> and <3cos^2([GRK]theta[grk]2)-1> as a function of the",
+    "[TT]-o[tt]: distribtion of [MATH][COS][GRK]theta[grk][SUB]1[sub][cos][math] for rmin<=r<=rmax.[PAR]",
+    "[TT]-no[tt]: distribution of [MATH][COS][GRK]theta[grk][SUB]2[sub][cos][math] for rmin<=r<=rmax.[PAR]",
+    "[TT]-ro[tt]: [MATH][CHEVRON][COS][GRK]theta[grk][SUB]1[sub][cos][chevron][math] and [MATH][CHEVRON]3[COS]^2[GRK]theta[grk][SUB]2[sub][cos]-1[chevron][math] as a function of the",
     "distance.[PAR]",
     "[TT]-co[tt]: the sum over all solvent molecules within distance r",
-    "of cos([GRK]theta[grk]1) and 3cos^2([GRK]theta[grk]2)-1 as a function of r.[PAR]",
+    "of [MATH][COS][GRK]theta[grk][SUB]1[sub][cos][math] and [MATH]3[COS]^2([GRK]theta[grk][SUB]2[sub])-1[cos][math] as a function of r.[PAR]",
     "[TT]-rc[tt]: the distribution of the solvent molecules as a function of r"
   };
  
index f85cc11d855c357edbf7a6ef86a9278f66b88c05..a1cd876af9b7dd9959f03a65c43b524c7b7cd7e2 100644 (file)
@@ -2285,7 +2285,7 @@ int gmx_tune_pme(int argc,char *argv[])
       { "-multi",     FALSE, etINT,  {&nmultisim},
         "Do multiple simulations in parallel" },
       { "-replex",    FALSE, etINT,  {&repl_ex_nst},
-        "Attempt replica exchange periodically with this period" },
+        "Attempt replica exchange periodically with this period (steps)" },
       { "-reseed",    FALSE, etINT,  {&repl_ex_seed},
         "Seed for replica exchange, -1 is generate a seed" },
       { "-rerunvsite", FALSE, etBOOL, {&bRerunVSite},
index d4b3cfda8bfa4c9c07c8c2d4384188b050b7119d..5acb833b538fea6a8400151ac70cb531fe7b671f 100644 (file)
@@ -218,7 +218,7 @@ int main(int argc,char *argv[])
     { "-hyd", FALSE, etBOOL, {&bH},
       "Include angles with atoms with mass < 1.5" },
     { "-hq", FALSE, etREAL, {&hq},
-      "Ignore angles with atoms with mass < 1.5 and |q| < hq" }
+      "Ignore angles with atoms with mass < 1.5 and magnitude of their charge less than this value" }
   };
  
   output_env_t oenv;