Fixed a lot of spelling errors in comments and documentation, collected by
authorDavid van der Spoel <spoel@xray.bmc.uu.se>
Sat, 12 Jun 2010 07:05:01 +0000 (09:05 +0200)
committerDavid van der Spoel <spoel@xray.bmc.uu.se>
Sat, 12 Jun 2010 07:05:01 +0000 (09:05 +0200)
Nicholas Breen. This fixes bug 435.

50 files changed:
include/3dview.h
include/futil.h
include/main.h
include/xtcio.h
scripts/make_gromos_nb.pl
scripts/make_gromos_rtp.py
share/html/online/xtc.html
src/gmxlib/atomprop.c
src/gmxlib/libxdrf.c
src/gmxlib/trxio.c
src/kernel/gmxcheck.c
src/kernel/pdb2gmx.c
src/kernel/specbond.c
src/kernel/tpbcmp.c
src/kernel/tpbconv.c
src/mdlib/edsam.c
src/mdlib/fft5d.c
src/mdlib/gmx_qhop_db.h
src/mdlib/nsgrid.c
src/mdlib/qmmm.c
src/tools/addconf.c
src/tools/autocorr.c
src/tools/expfit.c
src/tools/gmx_anaeig.c
src/tools/gmx_analyze.c
src/tools/gmx_angle.c
src/tools/gmx_bond.c
src/tools/gmx_clustsize.c
src/tools/gmx_dielectric.c
src/tools/gmx_dipoles.c
src/tools/gmx_editconf.c
src/tools/gmx_enemat.c
src/tools/gmx_energy.c
src/tools/gmx_genconf.c
src/tools/gmx_hbond.c
src/tools/gmx_helixorient.c
src/tools/gmx_mindist.c
src/tools/gmx_morph.c
src/tools/gmx_polystat.c
src/tools/gmx_rotacf.c
src/tools/gmx_sdf.c
src/tools/gmx_sgangle.c
src/tools/gmx_sham.c
src/tools/gmx_trjconv.c
src/tools/gmx_trjorder.c
src/tools/hxprops.c
src/tools/make_edi.c
src/tools/proptim.c
src/tools/readev.c
src/tools/recomb.c

index ec3cea0543acb6158710582265b5f4cfbd6c938b..9df08ab85a18b9f848693ff99703d3468fbc3140 100644 (file)
@@ -97,7 +97,7 @@ extern t_3dview *init_view(matrix box);
  */
 
 extern bool zoom_3d(t_3dview *view,real fac);
-/* Zoom in or out with factor fac, returns TRUE when zoom succesful,
+/* Zoom in or out with factor fac, returns TRUE when zoom successful,
  * FALSE otherwise.
  */
 
index 0fe7e08505a6b45db6dd73f74f376857ff09e1f8..3a0a15d44ae8d00747f38f14f626a1e36a4be6d1 100644 (file)
@@ -97,7 +97,7 @@ extern char *backup_fn(const char *file);
 extern bool make_backup(const char * file);
 
 extern FILE *ffopen(const char *file, const char *mode);
-/* Return a valid file pointer when succesfull, exits otherwise 
+/* Return a valid file pointer when successful, exits otherwise 
  * If the file is in compressed format, open a pipe which uncompresses
  * the file! Therefore, files must be closed with ffclose (see below)
  */
index f4aa2d3a9f1162a2bbb26ba160c71ce2c7d26226..0eba2af8dbdb21ea1c0f0336b0a54b896b10114e 100644 (file)
@@ -76,7 +76,7 @@ extern void check_multi_int(FILE *log,const gmx_multisim_t *ms,
 
 extern void init_multisystem(t_commrec *cr,int nsim,int nfile,
                              const t_filenm fnm[], bool bParFn);
-/* Splits the communication into nsim seperate simulations
+/* Splits the communication into nsim separate simulations
  * and creates a communication structure between the master
  * these simulations.
  * If bParFn is set, the nodeid is appended to the tpx and each output file.
index f6929b076cdf2e8c4c9671a4dc0c325d03cda3a3..8717e14ada0aed89f4b161f63b3ffe8c10aeea2a 100644 (file)
@@ -48,7 +48,7 @@
 extern "C" {
 #endif
 
-/* All functions return 1 if succesfull, 0 otherwise 
+/* All functions return 1 if successful, 0 otherwise 
  * bOK tells if a frame is not corrupted 
  */  
 
index 173156601dd12453bc4a7b001b337628697b392e..19f9f415aa6d10a91b1f81a80f45a1da919c92db 100755 (executable)
@@ -13,9 +13,9 @@
 # taken directly from ifp43a1.dat. For a description of what the numbers
 # mean, see the GROMOS96 manual and the fie ifp43a1.dat
 
-# set the input seperator to #--- so we read one atom entry at a time
-# make sure the records are actually seperated by #---\n and not by say #--\n!!
-# don't put a seperator at the end of the file, only between records
+# set the input separator to #--- so we read one atom entry at a time
+# make sure the records are actually separated by #---\n and not by say #--\n!!
+# don't put a separator at the end of the file, only between records
 $/= "#---\n"; 
 
 # start arrays with 1 instead of 0
index 3dd338dafc052c7402dd7d721b68ebdd8bf77e31..c672c2a2ac6675a334de6f2f06a01b577cf34860 100755 (executable)
@@ -253,7 +253,7 @@ for resnum in range(start,stop):    # loop through all residues
     f.getRESname(f.all[resnum])                # residue name
     f.getNATOM  (f.all[resnum])                # number of atoms
 
-    if f.nlin != 0:                    # 0 for a seperate molecule
+    if f.nlin != 0:                    # 0 for a separate molecule
           f.getEXCLUS(f.all[resnum])   # number of exclusions
 
     f.getATOM   (f.all[resnum])                # atoms                 => f.atoms
index 7fff1a6481c376c420e5c323352538fda58031f5..09bea49f3c4a3c8addebf77917487a820ad6cd5e 100644 (file)
@@ -20,7 +20,7 @@ performed, for instance making use of the fact that atoms close
 in sequence are usually close in space too (e.g. a water molecule).
 To this end, the <i>xdr</i> library is extended with a special routine
 to write 3-D float coordinates. This routine was written by Frans van Hoesel
-as part of an Europort project, and can be obtianed through <a href="http://hpcv100.rc.rug.nl/xdrf.html">this link</a>.
+as part of an Europort project, and can be obtained through <a href="http://hpcv100.rc.rug.nl/xdrf.html">this link</a>.
 <p>
 All the data is stored using calls to <i>xdr</i> routines.
 
@@ -46,7 +46,7 @@ All the data is stored using calls to <i>xdr</i> routines.
 <h3>Using xtc in your "C" programs</h3>
 To read and write these files the following "C" routines are available:
 <pre>
-/* All functions return 1 if succesfull, 0 otherwise */  
+/* All functions return 1 if successful, 0 otherwise */  
 
 extern int open_xtc(XDR *xd,char *filename,char *mode);
 /* Open a file for xdr I/O */
index 67f77f6dbac8cac6ccdcbec8c646737a1234307d..cd1eac8c8e66bc6202edad0b3d71b5c8f658f575 100644 (file)
@@ -128,7 +128,7 @@ static int get_prop_index(aprop_t *ap,t_aa_names *aan,
   if (debug) {
     fprintf(debug,"searching residue: %4s atom: %4s\n",resnm,atomnm);
     if (j == NOTFOUND)
-      fprintf(debug," not succesful\n");
+      fprintf(debug," not successful\n");
     else
       fprintf(debug," match: %4s %4s\n",ap->resnm[j],ap->atomnm[j]);
   }
index 50bb164866bfe6b343332bf6337f81fe08e02f3e..41550a57b78270bb943368227f7a41ef0ed8f505 100644 (file)
@@ -369,7 +369,7 @@ int xdropen(XDR *xdrs, const char *filename, const char *type) {
        return 0;
     }
     
-    /* next test isn't usefull in the case of C language
+    /* next test isn't useful in the case of C language
      * but is used for the Fortran interface
      * (C users are expected to pass the address of an already allocated
      * XDR staructure)
index b92d085662be922c05c60469335cf5c6b4078eb7..d62f4354897938817ffa526b9b3e3b0cf5a5a060 100644 (file)
@@ -538,7 +538,7 @@ static bool xyz_next_x(FILE *status, const output_env_t oenv,
 static int xyz_first_x(FILE *status, const output_env_t oenv, 
                        real *t, rvec **x, matrix box)
 /* Reads status, mallocs x, and returns x and box
- * Returns natoms when succesful, FALSE otherwise
+ * Returns natoms when successful, FALSE otherwise
  */
 {
   int    m;
index 1ee01e110fb232bcdd56ccaec94189545e43fd2f..67aa26da2975a6e10eff4b756b96fbc28695bb4e 100644 (file)
@@ -108,7 +108,7 @@ static void tpx2params(FILE *fp,t_inputrec *ir)
   fprintf(fp,"\\subsection{Simulation settings}\n");
   fprintf(fp,"A total of %g ns were simulated with a time step of %g fs.\n",
          ir->nsteps*ir->delta_t*0.001,1000*ir->delta_t);
-  fprintf(fp,"Neighborsearching was performed every %d steps.\n",ir->nstlist);
+  fprintf(fp,"Neighbor searching was performed every %d steps.\n",ir->nstlist);
   fprintf(fp,"The %s algorithm was used for electrostatic interactions.\n",
          EELTYPE(ir->coulombtype));
   fprintf(fp,"with a cut-off of %g nm.\n",ir->rcoulomb);  
@@ -605,13 +605,13 @@ int main(int argc,char *argv[])
     "radii) and atoms outside the box (these may occur often and are",
     "no problem). If velocities are present, an estimated temperature",
     "will be calculated from them.[PAR]",
-    "If an index file is given it's contents will be sumamrized.[PAR]",
+    "If an index file, is given its contents will be summarized.[PAR]",
     "If both a trajectory and a tpr file are given (with [TT]-s1[tt])",
     "the program will check whether the bond lengths defined in the tpr",
     "file are indeed correct in the trajectory. If not you may have",
     "non-matching files due to e.g. deshuffling or due to problems with",
     "virtual sites. With these flags, gmxcheck provides a quick check for such problems.[PAR]"
-    "The program can compare run two input ([TT].tpr[tt], [TT].tpb[tt] or",
+    "The program can compare two run input ([TT].tpr[tt], [TT].tpb[tt] or",
     "[TT].tpa[tt]) files",
     "when both [TT]-s1[tt] and [TT]-s2[tt] are supplied.",
     "Similarly a pair of trajectory files can be compared (using the [TT]-f2[tt]",
@@ -619,7 +619,7 @@ int main(int argc,char *argv[])
     "For free energy simulations the A and B state topology from one",
     "run input file can be compared with options [TT]-s1[tt] and [TT]-ab[tt].[PAR]",
     "In case the [TT]-m[tt] flag is given a LaTeX file will be written",
-    "consisting a rough outline for a methods section for a paper."
+    "consisting of a rough outline for a methods section for a paper."
   };
   t_filenm fnm[] = {
     { efTRX, "-f",  NULL, ffOPTRD },
index bb58770252c3e9fdfbed587b9a01ae21105a3586..ce4d69a00bc27a21080d2eebb36cbbddb9ba09af 100644 (file)
@@ -773,7 +773,7 @@ int main(int argc, char *argv[])
     "with a disulfide brigde or intermolecular distance restraints.[PAR]",
     
     "pdb2gmx will also check the occupancy field of the pdb file.",
-    "If any of the occupanccies are not one, indicating that the atom is",
+    "If any of the occupancies are not one, indicating that the atom is",
     "not resolved well in the structure, a warning message is issued.",
     "When a pdb file does not originate from an X-Ray structure determination",
     "all occupancy fields may be zero. Either way, it is up to the user",
@@ -1550,7 +1550,7 @@ int main(int argc, char *argv[])
   write_sto_conf(ftp2fn(efSTO,NFILE,fnm),title,atoms,x,NULL,ePBC,box);
 
   printf("\t\t--------- PLEASE NOTE ------------\n");
-  printf("You have succesfully generated a topology from: %s.\n",
+  printf("You have successfully generated a topology from: %s.\n",
         opt2fn("-f",NFILE,fnm));
   if (watstr[0] != NULL) {
     printf("The %s force field and the %s water model are used.\n",
index 7a95ae5f79a5713b35a86962bfcd12498017523f..f72a6dd7c32e233fcad80fda0c15ee82a4d4cc7f 100644 (file)
@@ -94,7 +94,7 @@ t_specbond *get_specbonds(int *nspecbond)
   }
   if (nlines > 0)
     sfree(lines);
-  fprintf(stderr,"%d out of %d lines of %s converted succesfully\n",
+  fprintf(stderr,"%d out of %d lines of %s converted successfully\n",
          n,nlines,sbfile);
          
   *nspecbond = n;
index eeaa9ca7aaf9fdd9189fab6ba28e71060117d972..bbeda38b2988f0113a5b8a479304836ede01a30d 100644 (file)
@@ -856,7 +856,7 @@ void comp_enx(const char *fn1,const char *fn2,real ftol,real abstol,const char *
     else if (!b1 && b2) 
       fprintf(stdout,"\nEnd of file on %s but not on %s\n",fn1,fn2);
     else if (!b1 && !b2)
-      fprintf(stdout,"\nFiles read succesfully\n");
+      fprintf(stdout,"\nFiles read successfully\n");
     else {
       cmp_real(stdout,"t",-1,fr1->t,fr2->t,ftol,abstol);
       cmp_int(stdout,"step",-1,fr1->step,fr2->step);
index 1e473ed8bb5644dfd0c33bc0ba1a7452bcde07a3..e80d19e169f354e7e09b4c6a35ab1908f0399465 100644 (file)
@@ -295,7 +295,7 @@ int main (int argc, char *argv[])
     "tpbconv can edit run input files in four ways.[PAR]"
     "[BB]1st.[bb] by modifying the number of steps in a run input file",
     "with option [TT]-nsteps[tt] or option [TT]-runtime[tt].[PAR]",
-    "[BB]2st.[bb] (OBSOLETE) by creating a run input file",
+    "[BB]2nd.[bb] (OBSOLETE) by creating a run input file",
     "for a continuation run when your simulation has crashed due to e.g.",
     "a full disk, or by making a continuation run input file.",
     "This option is obsolete, since mdrun now writes and reads",
@@ -304,11 +304,11 @@ int main (int argc, char *argv[])
     "When pressure and/or Nose-Hoover temperature coupling is used",
     "an energy file can be supplied to get an exact continuation",
     "of the original run.[PAR]",
-    "[BB]3nd.[bb] by creating a tpx file for a subset of your original",
+    "[BB]3rd.[bb] by creating a tpx file for a subset of your original",
     "tpx file, which is useful when you want to remove the solvent from",
     "your tpx file, or when you want to make e.g. a pure Ca tpx file.",
     "[BB]WARNING: this tpx file is not fully functional[bb].",
-    "[BB]4rd.[bb] by setting the charges of a specified group",
+    "[BB]4th.[bb] by setting the charges of a specified group",
     "to zero. This is useful when doing free energy estimates",
     "using the LIE (Linear Interaction Energy) method."
   };
index 38783fba33d783fc4930bee21583c2913b67ae9b..d0ea82f1f6dd25820889285f471d7188f6f8d0d5 100644 (file)
@@ -748,7 +748,7 @@ static void flood_blowup(t_edpar *edi, rvec *forces_cart)
      for every atom we add all the contributions to this atom from all the different eigenvectors.
 
      NOTE: one could add directly to the forcefield forces, would mean we wouldn't have to clear the 
-     field forces_cart prior the computation, but momentarily we want to compute the forces seperately 
+     field forces_cart prior the computation, but momentarily we want to compute the forces separately 
      to have them accessible for diagnostics
      */
     int  j,eig;
index 502b92ae55223805b75b71469b83cc5d84cb1063..7126a0e28a7fd551cfb447c8d78c379db36d8b92 100644 (file)
@@ -692,7 +692,7 @@ static void compute_offsets(fft5d_plan plan, int xs[], int xl[], int xc[], int N
         case 3: xs[i]=C[s]*pM[s];xc[i]=oK[s]; xl[i]=pK[s];break;
         }
     }
-    /*input order is different for test programm to match FFTW order 
+    /*input order is different for test program to match FFTW order 
       (important for complex to real)*/
     if (plan->flags&FFT5D_BACKWARD) {
         rotate(xs);
index ae5f2eafa554c8ea1179ee8e2cd56d9a48882681..5dd96582509bfa3903cc9904be5a061298288dbb 100644 (file)
@@ -11,15 +11,15 @@ typedef struct{
        
 typedef struct gmx_qhop_db_t *gmx_qhop_db;
 
-/* Return database if succesfull, or NULL on failure */
+/* Return database if successful, or NULL on failure */
 extern gmx_qhop_db gmx_qhop_db_read(char *forcefield);
  
-/* Write the database to a filename. Return 1 on succes, or 0 for
+/* Write the database to a filename. Return 1 on success, or 0 for
    failure */
 extern int gmx_qhop_db_write(char *fn,gmx_qhop_db qdb);
 
 /* Destroy the internal datastructures to free memory. Return 1 on
-   succes, 0 for failure */
+   success, 0 for failure */
 extern int gmx_qhop_db_done(gmx_qhop_db qdb);
 
 /* Return the number of states in the database for a given residue
index f16475cc9a2ff07a38e97c2f921a17acdb77c379..c1b1291b3cb7e592d60d81f71228ae17a9289d50 100644 (file)
@@ -420,7 +420,7 @@ void done_grid(t_grid *grid)
   grid->dc_nalloc = 0;
 
   if (debug) 
-    fprintf(debug,"Succesfully freed memory for grid pointers.");
+    fprintf(debug,"Successfully freed memory for grid pointers.");
 }
 
 int xyz2ci_(int nry,int nrz,int x,int y,int z)
index 109b3e61775cd4e381d0696d28d517061aa3244f..07b6e24d1829a060c0021ab818cbb30bd779fb07 100644 (file)
@@ -351,7 +351,7 @@ static void init_QMrec(int grpnr, t_QMrec *qm,int nr, int *atomarray,
   /* Lennard-Jones coefficients */ 
   snew(qm->c6,nr);
   snew(qm->c12,nr);
-  /* do we optimize the QM seperately using the algorithms of the QM program??
+  /* do we optimize the QM separately using the algorithms of the QM program??
    */
   qm->bTS      = ir->opts.bTS[grpnr];
   qm->bOPT     = ir->opts.bOPT[grpnr];
index 6380cacc59799ae598334274beb50fe0f241c57b..7688e90e1d74d5fbed601a86756f534e4e69b7d0 100644 (file)
@@ -307,7 +307,7 @@ void do_nsgrid(FILE *fp,bool bVerbose,
     dump_nblist(debug,cr,fr,0);
 
   if (bVerbose)    
-    fprintf(stderr,"Succesfully made neighbourlist\n");
+    fprintf(stderr,"Successfully made neighbourlist\n");
 }
 
 bool bXor(bool b1,bool b2)
index 926a305a074c9447e09643df786422800e69745e..7305d5419bbc48388d2955cb8fab0ae200a244fc 100644 (file)
@@ -745,7 +745,7 @@ t_pargs *add_acf_pargs(int *npargs,t_pargs *pa)
     { "-beginfit", FALSE, etREAL, {&acf.tbeginfit},
       "Time where to begin the exponential fit of the correlation function" },
     { "-endfit",   FALSE, etREAL, {&acf.tendfit},
-      "Time where to end the exponential fit of the correlation function, -1 is till the end" },
+      "Time where to end the exponential fit of the correlation function, -1 is until the end" },
    };
 #define NPA asize(acfpa)
   t_pargs *ppa;
index b6de7fececd008d5cec89ad143fbb8935d28d5ab..a511241b3600ee346bccede50e2e529f45ef7ddf 100644 (file)
@@ -412,7 +412,7 @@ real do_lmfit(int ndata,real c1[],real sig[],real dt,real x0[],
   nparm = nfp_ffn[eFitFn];
   if (debug) {
     fprintf(debug,"There are %d points to fit %d vars!\n",ndata,nparm);
-    fprintf(debug,"Fit to function %d from %g thru %g, dt=%g\n",
+    fprintf(debug,"Fit to function %d from %g through %g, dt=%g\n",
            eFitFn,begintimefit,endtimefit,dt);
   }
 
index faac172cfbaa785c3b157227b67a7fa175bd0eb0..ac26a9f9d03775f26f0a413cca86c481ea639f94 100644 (file)
@@ -737,7 +737,7 @@ int gmx_anaeig(int argc,char *argv[])
 {
   static const char *desc[] = {
     "[TT]g_anaeig[tt] analyzes eigenvectors. The eigenvectors can be of a",
-    "covariance matrix ([TT]g_covar[tt]) or of a Normal Modes anaysis",
+    "covariance matrix ([TT]g_covar[tt]) or of a Normal Modes analysis",
     "([TT]g_nmeig[tt]).[PAR]",
     
     "When a trajectory is projected on eigenvectors, all structures are",
@@ -757,7 +757,7 @@ int gmx_anaeig(int argc,char *argv[])
     "[TT]-first[tt] to [TT]-last[tt].",
     "The projections of a trajectory on the eigenvectors of its",
     "covariance matrix are called principal components (pc's).",
-    "It is often useful to check the cosine content the pc's,",
+    "It is often useful to check the cosine content of the pc's,",
     "since the pc's of random diffusion are cosines with the number",
     "of periods equal to half the pc index.",
     "The cosine content of the pc's can be calculated with the program",
index 3629730288c167b662b5dc0ad62e9a2c640daeb3..178b53830d8fc5d0fd064256a8ec066ff11db35f 100644 (file)
@@ -882,7 +882,7 @@ int gmx_analyze(int argc,char *argv[])
     "A line in the input file may start with a time",
     "(see option [TT]-time[tt]) and any number of y values may follow.",
     "Multiple sets can also be",
-    "read when they are seperated by & (option [TT]-n[tt]),",
+    "read when they are separated by & (option [TT]-n[tt]),",
     "in this case only one y value is read from each line.",
     "All lines starting with # and @ are skipped.",
     "All analyses can also be done for the derivative of a set",
@@ -893,7 +893,7 @@ int gmx_analyze(int argc,char *argv[])
 
     "g_analyze always shows the average and standard deviation of each",
     "set. For each set it also shows the relative deviation of the third",
-    "and forth cumulant from those of a Gaussian distribution with the same",
+    "and fourth cumulant from those of a Gaussian distribution with the same",
     "standard deviation.[PAR]",
 
     "Option [TT]-ac[tt] produces the autocorrelation function(s).[PAR]",
@@ -986,7 +986,7 @@ int gmx_analyze(int argc,char *argv[])
     { "-e",       FALSE, etREAL, {&te},
       "Last time to read from set" },
     { "-n",       FALSE, etINT, {&nsets_in},
-      "Read # sets seperated by &" },
+      "Read # sets separated by &" },
     { "-d",       FALSE, etBOOL, {&bDer},
        "Use the derivative" },
     { "-dp",      FALSE, etINT, {&d}, 
index 0c2d69ed9162699ad00818b88b1a9f764f4b9686..a773bfa891e2327b932db0b5b39f1be1dbc7b8cd 100644 (file)
@@ -104,7 +104,7 @@ int gmx_g_angle(int argc,char *argv[])
     "It should be noted that the indexfile should contain",
     "atom-triples for angles or atom-quadruplets for dihedrals.",
     "If this is not the case, the program will crash.[PAR]",
-    "With option [TT]-or[tt] a trajectory file is dumped containing cos and"
+    "With option [TT]-or[tt] a trajectory file is dumped containing cos and "
     "sin of selected dihedral angles which subsequently can be used as",
     "input for a PCA analysis using [TT]g_covar[tt]."
   };
index 0b0ec2eb1b0b74dd326ba7c44ab7328a1e677ca9..9bd1197c8173d250ab3591d92b0d667f4e9a8691 100644 (file)
@@ -228,8 +228,8 @@ int gmx_bond(int argc,char *argv[])
   const char *desc[] = {
     "g_bond makes a distribution of bond lengths. If all is well a",
     "gaussian distribution should be made when using a harmonic potential.",
-    "bonds are read from a single group in the index file in order i1-j1",
-    "i2-j2 thru in-jn.[PAR]",
+    "Bonds are read from a single group in the index file in order i1-j1",
+    "i2-j2 through in-jn.[PAR]",
     "[TT]-tol[tt] gives the half-width of the distribution as a fraction",
     "of the bondlength ([TT]-blen[tt]). That means, for a bond of 0.2",
     "a tol of 0.1 gives a distribution from 0.18 to 0.22.[PAR]",
index 18f45f36cc3781ef8e351abbdae880c922da4a89..ecb50f518daebfd157f4ecc15ce3a64ac5f58a0c 100644 (file)
@@ -360,7 +360,7 @@ int gmx_clustsize(int argc,char *argv[])
     "When the [TT]-mol[tt] option is given clusters will be made out of",
     "molecules rather than atoms, which allows clustering of large molecules.",
     "In this case an index file would still contain atom numbers",
-    "or your calculcation will die with a SEGV.[PAR]",
+    "or your calculation will die with a SEGV.[PAR]",
     "When velocities are present in your trajectory, the temperature of",
     "the largest cluster will be printed in a separate xvg file assuming",
     "that the particles are free to move. If you are using constraints,",
@@ -395,7 +395,7 @@ int gmx_clustsize(int argc,char *argv[])
     { "-nlevels",  FALSE, etINT,  {&nlevels},
       "Number of levels of grey in xpm output" },
     { "-ndf",      FALSE, etINT,  {&ndf},
-      "Number of degrees of freedom of the entire system for temperature calculation. If not set the number of atoms times three is used." },
+      "Number of degrees of freedom of the entire system for temperature calculation. If not set, the number of atoms times three is used." },
     { "-rgblo",    FALSE, etRVEC, {rlo},
       "RGB values for the color of the lowest occupied cluster size" },
     { "-rgbhi",    FALSE, etRVEC, {rhi},
index 7db575e7021e43e3a1a7b58f5ead31a72345d2f5..fb13f5a85cdedaa3ee92ce1d55552e3df5aa64ec 100644 (file)
@@ -97,7 +97,7 @@ real numerical_deriv(int nx,real x[],real y[],real fity[],real combined[],real d
   else {
     i0 = max(0,nbegin);
     i1 = min(nx-1,nbegin+nsmooth);
-    printf("Making smooth transition from %d thru %d\n",i0,i1);
+    printf("Making smooth transition from %d through %d\n",i0,i1);
     for(i=0; (i<i0); i++)
       combined[i]=y[i];
     for(i=i0; (i<=i1); i++) {
@@ -201,10 +201,10 @@ int gmx_dielectric(int argc,char *argv[])
     "For an estimate of the error you can run g_statistics on the",
     "ACF, and use the output thus generated for this program.",
     "The functional forms of the available functions are:[PAR]",
-    "One parmeter  : y = Exp[-a1 x]",
-    "Two parmeters : y = a2 Exp[-a1 x]",
-    "Three parmeter: y = a2 Exp[-a1 x] + (1 - a2) Exp[-a3 x]",
-    "Startvalues for the fit procedure can be given on the commandline.",
+    "One parameter  : y = Exp[-a1 x],",
+    "Two parameters : y = a2 Exp[-a1 x],",
+    "Three parameters: y = a2 Exp[-a1 x] + (1 - a2) Exp[-a3 x].",
+    "Start values for the fit procedure can be given on the command line.",
     "It is also possible to fix parameters at their start value, use -fix",
     "with the number of the parameter you want to fix.",
     "[PAR]",
@@ -213,10 +213,10 @@ int gmx_dielectric(int argc,char *argv[])
     "numerical derivative of the combination data/fit.",
     "The second file contains the real and imaginary parts of the",
     "frequency-dependent dielectric constant, the last gives a plot",
-    "known as the Cole-Cole plot, in which the  imaginary",
+    "known as the Cole-Cole plot, in which the imaginary",
     "component is plotted as a function of the real component.",
     "For a pure exponential relaxation (Debye relaxation) the latter",
-    "plot should be one half of a circle"
+    "plot should be one half of a circle."
   };
   t_filenm fnm[] = {
     { efXVG, "-f", "dipcorr",ffREAD  },
index f94c92336316d0bd24056eee82eacebdee4e0a80..002248a9baee812ba7633897d5e5cdc3f0c19e46 100644 (file)
@@ -1221,7 +1221,7 @@ int gmx_dipoles(int argc,char *argv[])
     "option -corr is used. The output file name is given with the [TT]-c[tt]",
     "option.",
     "The correlation functions can be averaged over all molecules",
-    "([TT]mol[tt]), plotted per molecule seperately ([TT]molsep[tt])",
+    "([TT]mol[tt]), plotted per molecule separately ([TT]molsep[tt])",
     "or it can be computed over the total dipole moment of the simulation box",
     "([TT]total[tt]).[PAR]",
     "Option [TT]-g[tt] produces a plot of the distance dependent Kirkwood",
@@ -1256,7 +1256,7 @@ int gmx_dipoles(int argc,char *argv[])
     { "-mumax",    FALSE, etREAL, {&mu_max},
       "max dipole in Debye (for histrogram)" },
     { "-epsilonRF",FALSE, etREAL, {&epsilonRF},
-      "epsilon of the reaction field used during the simulation, needed for dieclectric constant calculation. WARNING: 0.0 means infinity (default)" },
+      "epsilon of the reaction field used during the simulation, needed for dielectric constant calculation. WARNING: 0.0 means infinity (default)" },
     { "-skip",     FALSE, etINT, {&skip},
       "Skip steps in the output (but not in the computations)" },
     { "-temp",     FALSE, etREAL, {&temp},
index 3445dae339efd5c772c4df0fa836470b912562d0..d116a55fda87114a1713abb6a8aecd4c2cb5051f 100644 (file)
@@ -538,7 +538,7 @@ int gmx_editconf(int argc, char *argv[])
     const char *bugs[] =
         {
             "For complex molecules, the periodicity removal routine may break down, "
-                "in that case you can use trjconv" };
+                "in that case you can use trjconv." };
     static real dist = 0.0, rbox = 0.0, to_diam = 0.0;
     static bool bNDEF = FALSE, bRMPBC = FALSE, bCenter = FALSE, bReadVDW =
         FALSE, bCONECT = FALSE;
index 786a90997197fd1f2b01cb499b3ed1b44e2b7ac1..89fbdf40c71ce522b2d63b86ad0e5ac0453dd1be 100644 (file)
@@ -117,7 +117,7 @@ int gmx_enemat(int argc,char *argv[])
     { "-skip", FALSE, etINT,  {&skip},
       "Skip number of frames between data points" },
     { "-mean", FALSE, etBOOL, {&bMeanEmtx},
-      "with -groups extracts matrix of mean energies in stead of "
+      "with -groups extracts matrix of mean energies instead of "
       "matrix for each timestep" },
     { "-nlevels", FALSE, etINT, {&nlevels},"number of levels for matrix colors"},
     { "-max",FALSE, etREAL, {&cutmax},"max value for energies"},
index 512da376d461698ccb93961aaeea839c937ff3e7..3fe199a08296fa0f22654bad123ba0562c817d42 100644 (file)
@@ -878,7 +878,7 @@ static void analyse_ener(bool bCorr,const char *corrfn,
     /* Calculate the time difference */
     delta_t = t - start_t;
     
-    fprintf(stdout,"\nStatistics over %s steps [ %.4f thru %.4f ps ], %d data sets\n",
+    fprintf(stdout,"\nStatistics over %s steps [ %.4f through %.4f ps ], %d data sets\n",
            gmx_step_str(nsteps,buf),start_t,t,nset);
 
     calc_averages(nset,edat,nbmin,nbmax);
index beb071407c2f9b95e025ec513156f70f5db98555..fce46cb77723a4d36f7261404eecb4ae41b4edae 100644 (file)
@@ -124,7 +124,7 @@ int gmx_genconf(int argc, char *argv[])
     
   };
   const char *bugs[] = {
-    "The program should allow for random displacement off lattice points." };
+    "The program should allow for random displacement of lattice points." };
 
   int     vol;          
   t_atoms *atoms;       /* list with all atoms */
index 4ce44054636859ad025a54911100ea09e388af61..39f2149c6c412dda13bb33a902124569caa323eb 100644 (file)
@@ -984,7 +984,7 @@ static void add_h2d(int id,int ih,t_donors *ddd)
   
     for(i=0; (i<ddd->nhydro[id]); i++) 
         if (ddd->hydro[id][i] == ih) {
-            printf("Hm. This isn't first time I find this donor (%d,%d)\n",
+            printf("Hm. This isn't the first time I found this donor (%d,%d)\n",
                    ddd->don[id],ih);
             break;
         }
@@ -3131,7 +3131,7 @@ int gmx_hbond(int argc,char *argv[])
         "into hydrogen bonds. Ordering is identical to that in [TT]-hbn[tt]",
         "index file.[BR]",
         "[TT]-dan[tt]: write out the number of donors and acceptors analyzed for",
-        "each timeframe. This is especially usefull when using [TT]-shell[tt].[BR]",
+        "each timeframe. This is especially useful when using [TT]-shell[tt].[BR]",
         "[TT]-nhbdist[tt]: compute the number of HBonds per hydrogen in order to",
         "compare results to Raman Spectroscopy.",
         "[PAR]",
@@ -3196,7 +3196,7 @@ int gmx_hbond(int argc,char *argv[])
           "Number of threads used for the parallel loop over autocorrelations. nThreads <= 0 means maximum number of threads. Requires linking with OpenMP. The number of threads is limited by the number of processors (before OpenMP v.3 ) or environment variable OMP_THREAD_LIMIT (OpenMP v.3)"},
 #endif
         { "-NN", FALSE, etENUM, {NNtype},
-          "HIDDENDo a full all vs all loop and estimsate the interaction energy instead of having a binary existence function for hydrogen bonds. NOT FULLY TESTED YET! DON'T USE IT!"},
+          "HIDDENDo a full all vs all loop and estimate the interaction energy instead of having a binary existence function for hydrogen bonds. NOT FULLY TESTED YET! DON'T USE IT!"},
         { "-gemfit", FALSE, etBOOL, {&bGemFit},
           "With -gemainate != none: fit ka and kd to the ACF"},
 /*         { "-gemlogstart", FALSE, etREAL, {&logAfterTime}, */
index 2fd5289339f3b690de50e500bdffbda00c70fd03..8ce9917de0309c274e3dc2635015ef0740f3877f 100644 (file)
@@ -58,7 +58,7 @@
 int gmx_helixorient(int argc,char *argv[])
 {
   const char *desc[] = {
-    "g_helixorient calculates coordinates and direction of the average",
+    "g_helixorient calculates the coordinates and direction of the average",
     "axis inside an alpha helix, and the direction/vectors of both the",
     "alpha carbon and (optionally) a sidechain atom relative to the axis.[PAR]",
     "As input, you need to specify an index group with alpha carbon atoms",
index 641b63d9d5d5895a9583af5d5a839e049ece4627..98d4966598b6d6bbe5007fd068a34efd1ab16cd0 100644 (file)
@@ -481,7 +481,7 @@ int gmx_mindist(int argc,char *argv[])
     "with multiple atoms in the first group is counted as one contact",
     "instead of as multiple contacts.",
     "With [TT]-or[tt], minimum distances to each residue in the first",
-    "group are determined and plotted as a function of reisdue number.[PAR]",
+    "group are determined and plotted as a function of residue number.[PAR]",
     "With option [TT]-pi[tt] the minimum distance of a group to its",
     "periodic image is plotted. This is useful for checking if a protein",
     "has seen its periodic image during a simulation. Only one shift in",
index a553e258d6f1436f57bb67495f2064255dd297e2..91845f433a3f3fbc625daf16d2cd553a60bb0923 100644 (file)
@@ -73,7 +73,7 @@ int gmx_morph(int argc,char *argv[])
     "generic trajectory. The number of intermediates can be controlled with",
     "the -ninterm flag. The first and last flag correspond to the way of",
     "interpolating: 0 corresponds to input structure 1 while",
-    "1 corresponds to input strucutre 2.",
+    "1 corresponds to input structure 2.",
     "If you specify first < 0 or last > 1 extrapolation will be",
     "on the path from input structure x1 to x2. In general the coordinates",
     "of the intermediate x(i) out of N total intermidates correspond to:[PAR]",
index 8f54eb3fe4bb55e42f1e8238f731c962f5e9fb91..429424250547ee9aa5b940246065953d314ccfac 100644 (file)
@@ -109,10 +109,10 @@ int gmx_polystat(int argc,char *argv[])
     "gyration tensors are written.",
     "With option [TT]-i[tt] the mean square internal distances are",
     "written.[PAR]",
-    "With option [TT]-p[tt] the presistence length is determined.",
+    "With option [TT]-p[tt] the persistence length is determined.",
     "The chosen index group should consist of atoms that are",
     "consecutively bonded in the polymer mainchains.",
-    "The presistence length is then determined from the cosine of",
+    "The persistence length is then determined from the cosine of",
     "the angles between bonds with an index difference that is even,",
     "the odd pairs are not used, because straight polymer backbones",
     "are usually all trans and therefore only every second bond aligns.",
index 677c4e7e287957c7d1359b4e4b976a96f94614c6..beedaabfc2b6a56e89214a132842d2251c24c5c0 100644 (file)
@@ -73,7 +73,7 @@ int gmx_rotacf(int argc,char *argv[])
     "This will calculate the rotational correlation function using a first",
     "order Legendre polynomial of the angle of a vector defined by the index",
     "file. The correlation function will be fitted from 2.5 ps till 20.0 ps",
-    "to a two parameter exponential",
+    "to a two parameter exponential.",
 
 
     ""
index 4611c10c69d3edb6c4d8fbcf4a7f84c44127b2a4..63813dab6bd8dbfd8a40de541fb48d5ec90e0ec0 100644 (file)
@@ -344,7 +344,7 @@ structure if needed */
     rm_pbc(&top.idef,ePBC,natoms,box,x,x);
 
 
-    /* Dynamically build the ref tripels */
+    /* Dynamically build the ref triples */
     if ( mode == 2 )
       {
         isize[NDX_REF1]=0;
@@ -564,7 +564,7 @@ structure if needed */
 
 
   /* Calculate the mean probability density */
-  fprintf(stderr,"\nNumber of configuations used for SDF: %d\n",(int)normfac);
+  fprintf(stderr,"\nNumber of configurations used for SDF: %d\n",(int)normfac);
 
 
   normfac = nbin[0]*nbin[1]*nbin[2] / normfac;
@@ -652,7 +652,7 @@ int gmx_sdf(int argc,char *argv[])
     "file to work. ",
     "You have to setup 4 groups in the index file before using g_sdf: [PAR]",
     "The first three groups are used to define the SDF coordinate system.",
-    "The programm will dynamically generate the atom tripels according to ",
+    "The program will dynamically generate the atom triples according to ",
     "the selected -mode: ", 
     "In -mode 1 the triples will be just the 1st, 2nd, 3rd, ... atoms from ",
     "groups 1, 2 and 3. Hence the nth entries in groups 1, 2 and 3 must be from the",
@@ -680,7 +680,7 @@ int gmx_sdf(int argc,char *argv[])
     "Use -bin to set the binwidth for grid.[PAR]",
     "The output will be a binary 3D-grid file (gom_plt.dat) in the .plt format that can be be",
     "read directly by gOpenMol. ",
-    "The option -r will generate a .gro file with the reference molecule(s) transfered to",
+    "The option -r will generate a .gro file with the reference molecule(s) transferred to",
     "the SDF coordinate system. Load this file into gOpenMol and display the",
     "SDF as a contour plot (see http://www.csc.fi/gopenmol/index.phtml for ",
     "further documentation). [PAR]",
index 449c33d7e1abb1d3dddf3740578f0d550d91fb2c..990a89e0d3eaa2fcb5459c9ae5d21147ed6f10ba 100644 (file)
@@ -442,7 +442,7 @@ int gmx_sgangle(int argc,char *argv[])
     "Here is what some of the file options do:[BR]",
     "-oa: Angle between the two groups specified in the index file. If a group contains three atoms the normal to the plane defined by those three atoms will be used. If a group contains two atoms, the vector defined by those two atoms will be used.[BR]",
     "-od: Distance between two groups. Distance is taken from the center of one group to the center of the other group.[BR]",
-    "-od1: If one plane and one vector is given, the distances for each of the atoms from the center of the plane is given seperately.[BR]",
+    "-od1: If one plane and one vector is given, the distances for each of the atoms from the center of the plane is given separately.[BR]",
     "-od2: For two planes this option has no meaning."
   };
 
index 4f36bef2a08876095e8e6cc5f4729584eebdca46..d623b9249e09819ad15acc19dd4d7926c419a431 100644 (file)
@@ -688,7 +688,7 @@ int gmx_sham(int argc,char *argv[])
     "A line in the input file may start with a time",
     "(see option [TT]-time[tt]) and any number of y values may follow.",
     "Multiple sets can also be",
-    "read when they are seperated by & (option [TT]-n[tt]),",
+    "read when they are separated by & (option [TT]-n[tt]),",
     "in this case only one y value is read from each line.",
     "All lines starting with # and @ are skipped.",
     "[PAR]",
@@ -737,7 +737,7 @@ int gmx_sham(int argc,char *argv[])
     { "-ttol",     FALSE, etREAL, {&ttol},
       "Tolerance on time in appropriate units (usually ps)" },
     { "-n",       FALSE, etINT, {&nsets_in},
-      "Read # sets seperated by &" },
+      "Read # sets separated by &" },
     { "-d",       FALSE, etBOOL, {&bDer},
        "Use the derivative" },
     { "-bw",      FALSE, etREAL, {&binwidth},
index 1c7a3fe41fdc4e358e8ba427c4feba2e8c4ee026..c85e60c18e1a408a0305c56595c136809e59aa47 100644 (file)
@@ -518,7 +518,7 @@ int gmx_trjconv(int argc,char *argv[])
         "append output to an existing trajectory file.",
         "No checks are performed to ensure integrity",
         "of the resulting combined trajectory file.[PAR]",
-        "Option [TT]-sep[tt] can be used to write every frame to a seperate",
+        "Option [TT]-sep[tt] can be used to write every frame to a separate",
         ".gro, .g96 or .pdb file, default all frames all written to one file.",
         "[TT].pdb[tt] files with all frames concatenated can be viewed with",
         "[TT]rasmol -nmrpdb[tt].[PAR]",
@@ -559,7 +559,7 @@ int gmx_trjconv(int argc,char *argv[])
         "* [TT]whole[tt] only makes broken molecules whole.[PAR]",
         "Option [TT]-ur[tt] sets the unit cell representation for options",
         "[TT]mol[tt], [TT]res[tt] and [TT]atom[tt] of [TT]-pbc[tt].",
-        "All three options give different results for triclinc boxes and",
+        "All three options give different results for triclinic boxes and",
         "identical results for rectangular boxes.",
         "[TT]rect[tt] is the ordinary brick shape.",
         "[TT]tric[tt] is the triclinic unit cell.", 
index 2019eaf7e4363f00783399dc79a6c7e74d57a8a1..69e03e652bc89abb454a98f9d1d56adfc6f49eb9 100644 (file)
@@ -102,7 +102,7 @@ int gmx_trjorder(int argc,char *argv[])
     "will be stored in the B-factor field in order to color with e.g. rasmol.",
     "[PAR]",
     "With option [TT]-nshell[tt] the number of molecules within a shell",
-    "of radius [TT]-r[tt] around the refernce group are printed."
+    "of radius [TT]-r[tt] around the reference group are printed."
   };
   static int na=3,ref_a=1;
   static real rcut=0;
index f430a38baf659cdac7cff02b0f617da57dfb2940..f16fdf4d64086505b7e86425f4188caf492c1a28 100644 (file)
@@ -509,7 +509,7 @@ void do_start_end(int nres,t_bb bb[],rvec x[],int *nbb,atom_id bbindex[],
     /* Find start and end of longest helix fragment */
     check_ahx(nres,bb,x,&hstart,&hend);
   }
-  fprintf(stderr,"helix from: %d thru %d\n",
+  fprintf(stderr,"helix from: %d through %d\n",
          bb[hstart].resno,bb[hend].resno);
   
   for(j=0,i=hstart; (i<=hend); i++) {
index 01142f8264c21bf00950f7bf5fd37cfc912978ca..d6e8a6c0887afa00a6db69e3dec270e07d6aac40 100644 (file)
@@ -366,13 +366,13 @@ void read_eigenvalues(int vecs[],const char *eigfile, real values[],
   if (bHesse)
     for (i=0; vecs[i]; i++) {
       if (vecs[i]<7)
-       gmx_fatal(FARGS,"ERROR: You have choosen one of the first 6 eigenvectors of the HESSE Matrix. That does not make sense, since they correspond to the 6 rotational and translational degrees of freedom.\n\n");
+       gmx_fatal(FARGS,"ERROR: You have chosen one of the first 6 eigenvectors of the HESSE Matrix. That does not make sense, since they correspond to the 6 rotational and translational degrees of freedom.\n\n");
       values[i]=eigval[1][vecs[i]-1]/kT;
     }
   else
     for (i=0; vecs[i]; i++) {
       if (vecs[i]>(neig-6))
-       gmx_fatal(FARGS,"ERROR: You have choosen one of the last 6 eigenvectors of the COVARIANCE Matrix. That does not make sense, since they correspond to the 6 rotational and translational degrees of freedom.\n\n");
+       gmx_fatal(FARGS,"ERROR: You have chosen one of the last 6 eigenvectors of the COVARIANCE Matrix. That does not make sense, since they correspond to the 6 rotational and translational degrees of freedom.\n\n");
       values[i]=1/eigval[1][vecs[i]-1];
     }
   /* free memory */
index faf13f8f11b393f8e0dda33be0899f59d5ef5c06..5541dc1000f921a505bf19ac975a4065d4112430 100644 (file)
@@ -151,11 +151,11 @@ void proptrj(char *fngro,char *fndat,t_topology *top,t_pinp *p)
   snew(xav,natoms);
   snew(vav,natoms);
   read_conf(fngro,buf,&natoms,xav,vav,box);
-  fprintf(stderr,"Succesfully read average positions (%s)\n",buf);
+  fprintf(stderr,"Successfully read average positions (%s)\n",buf);
   
   EV=read_ev(fndat,natoms);
   
-  fprintf(stderr,"Succesfully read eigenvectors\n");
+  fprintf(stderr,"Successfully read eigenvectors\n");
 
   snew(index,nev);
   for(i=0; (i<nev); i++)
index 4c5a4f653dc2944f6b47371e65bef7a87be6bad1..e7f71ea2c27bd2dacae0583aed3d9746ef224ec7 100644 (file)
@@ -84,7 +84,7 @@ real **read_proj(int nev,int nframes,char *base)
     }
     ffclose(in);
   }
-  fprintf(stderr,"\rSuccesfully read eigenvector projections\n");
+  fprintf(stderr,"\rSuccessfully read eigenvector projections\n");
   
   return evprj;
 }
index e942f3637457dd3bda3e49462de9d734bb8c091a..a34260e398f4a57235a0b51e48a0babbd34f6ec9 100644 (file)
@@ -55,7 +55,7 @@ real *read_gammaf(char *fn,int nframes)
     gf[i]=y;
   }
   ffclose(in);
-  fprintf(stderr,"Succesfully read gamma\n");
+  fprintf(stderr,"Successfully read gamma\n");
   return gf;
 }