Rename 'gmx tpbconv' to 'gmx convert-tpr'
authorMark Abraham <mark.j.abraham@gmail.com>
Sat, 18 Jan 2014 21:31:47 +0000 (22:31 +0100)
committerMark Abraham <mark.j.abraham@gmail.com>
Mon, 20 Jan 2014 21:05:08 +0000 (22:05 +0100)
This should help people find the tool they are looking for, rather
than one that is named for a file format that hasn't been written in
over 5 years. Updated comments and documentation accordingly.

Uncrustified, added copyright headers.

Change-Id: I5c29c30af54b90081cfb44f5b24764c8280c49fa

share/html/online/files.html
share/html/online/mdp_opt.html
src/gromacs/gmxlib/mshift.c
src/gromacs/legacyheaders/types/inputrec.h
src/gromacs/tools/convert_tpr.c [moved from src/gromacs/tools/tpbconv.c with 98% similarity]
src/gromacs/tools/convert_tpr.h [moved from src/gromacs/tools/tpbconv.h with 92% similarity]
src/programs/gmx/grompp.c
src/programs/gmx/legacymodules.cpp

index 9be08f4729354894f249e69a547794bebb42af6c..dc84d82fe8bc36a578a085a67596929e205b54d2 100644 (file)
@@ -5,7 +5,7 @@
 <a href="mdp.html">mdp</a>
 <dd>run parameters, input for
 <a href="../programs/gmx-grompp.html">gmx grompp</a> and
-<a href="../programs/tpbconv.html">gmx tpbconv</a>
+<a href="../programs/gmx-convert-tpr.html">gmx convert-tpr</a>
 <dt><a href="m2p.html">m2p</a>
 <dd>input for <a href="../programs/xpm2ps.html">gmx xpm2ps</a>
 </dl>
index e63311dd48cf6c577bfa7ba57f72da3a02baa584..a759d4df727baf750295fe3d19f5cccaa94a9ef1 100644 (file)
@@ -233,7 +233,7 @@ The free-energy lambda is calculated as: lambda = <tt>init-lambda</tt> + <tt>del
 Also non-equilibrium MD parameters can depend on the step number.
 Thus for exact restarts or redoing part of a run it might be necessary to
 set <tt>init-step</tt> to the step number of the restart frame.
-<tt>tpbconv</tt> does this automatically.
+<tt>gmx convert-tpr</tt> does this automatically.
 </dd>
 <dt><b>comm-mode:</b></dt>
 <dd><dl compact>
index ec0bc79c2ec641a0b6e861dd6e47befb1d92c6fa..0b688298b2af178f46cbab22ed999922c7676f53 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -110,7 +110,7 @@ static void mk_igraph(t_graph *g, int ftype, t_ilist *il,
                           "above natoms (%d).\n"
                           "You are probably trying to use a trajectory which does "
                           "not match the first %d atoms of the run input file.\n"
-                          "You can make a matching run input file with tpbconv.",
+                          "You can make a matching run input file with gmx convert-tpr.",
                           at_end, at_end);
             }
             if (ftype == F_SETTLE)
index b3746da2cacd98886ead20922ab4a6d099c3c320..2e8d678cfffd40fdba1af13ca15c7d03b1dff9fe 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -295,7 +295,7 @@ typedef struct {
     int             eI;                      /* Integration method                 */
     gmx_int64_t     nsteps;                  /* number of steps to be taken                    */
     int             simulation_part;         /* Used in checkpointing to separate chunks */
-    gmx_int64_t     init_step;               /* start at a stepcount >0 (used w. tpbconv)    */
+    gmx_int64_t     init_step;               /* start at a stepcount >0 (used w. convert-tpr)    */
     int             nstcalcenergy;           /* frequency of energy calc. and T/P coupl. upd.  */
     int             cutoff_scheme;           /* group or verlet cutoffs     */
     int             ns_type;                 /* which ns method should we use?               */
similarity index 98%
rename from src/gromacs/tools/tpbconv.c
rename to src/gromacs/tools/convert_tpr.c
index ff39619810f7853fd8a96761d087a98d40c3adf0..e1cf09dcd1dd3dbde18342b457b3b578d1c14eb4 100644 (file)
@@ -321,7 +321,7 @@ static void zeroq(atom_id index[], gmx_mtop_t *mtop)
     }
 }
 
-int gmx_tpbconv(int argc, char *argv[])
+int gmx_convert_tpr(int argc, char *argv[])
 {
     const char       *desc[] = {
         "[THISMODULE] can edit run input files in four ways.[PAR]",
@@ -438,10 +438,10 @@ int gmx_tpbconv(int argc, char *argv[])
     if (bTraj)
     {
         fprintf(stderr, "\n"
-                "NOTE: Reading the state from trajectory is an obsolete feature of tpbconv.\n"
+                "NOTE: Reading the state from trajectory is an obsolete feature of gmx convert-tpr.\n"
                 "      Continuation should be done by loading a checkpoint file with mdrun -cpi\n"
                 "      This guarantees that all state variables are transferred.\n"
-                "      tpbconv is now only useful for increasing nsteps,\n"
+                "      gmx convert-tpr is now only useful for increasing nsteps,\n"
                 "      but even that can often be avoided by using mdrun -maxh\n"
                 "\n");
 
@@ -460,7 +460,7 @@ int gmx_tpbconv(int argc, char *argv[])
         if (ir->epc != epcNO || EI_SD(ir->eI) || ir->eI == eiBD)
         {
             fprintf(stderr, "NOTE: The simulation uses pressure coupling and/or stochastic dynamics.\n"
-                    "tpbconv can not provide binary identical continuation.\n"
+                    "gmx convert-tpr can not provide binary identical continuation.\n"
                     "If you want that, supply a checkpoint file to mdrun\n\n");
         }
 
similarity index 92%
rename from src/gromacs/tools/tpbconv.h
rename to src/gromacs/tools/convert_tpr.h
index abc0d1be30cff030c74a793ba801a9e608556326..bb7fc46c445bb55f2f4219956b5eea05451a3ece 100644 (file)
@@ -32,8 +32,8 @@
  * 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_TOOLS_TPBCONV_H
-#define GMX_TOOLS_TPBCONV_H
+#ifndef GMX_TOOLS_CONVERT_TPR_H
+#define GMX_TOOLS_CONVERT_TPR_H
 
 #ifdef __cplusplus
 extern "C" {
@@ -42,12 +42,12 @@ extern "C" {
 }
 #endif
 
-/*! \brief Implements gmx tpbconv
+/*! \brief Implements gmx convert-tpr
  *
  * \param[in] argc  argc value passed to main().
  * \param[in] argv  argv array passed to main().
  */
-int gmx_tpbconv(int argc, char *argv[]);
+int gmx_convert_tpr(int argc, char *argv[]);
 
 #ifdef __cplusplus
 }
index b1e77afdb65bba9a0a3e9ae21966513307a24565..1bc1da737cefd4f3e0c879e5b597990099c94812 100644 (file)
@@ -737,7 +737,7 @@ static void cont_status(const char *slog, const char *ener,
 
     /* Set the relative box lengths for preserving the box shape.
      * Note that this call can lead to differences in the last bit
-     * with respect to using tpbconv to create a [TT].tpx[tt] file.
+     * with respect to using gmx convert-tpr to create a [TT].tpx[tt] file.
      */
     set_box_rel(ir, state);
 
@@ -1388,7 +1388,7 @@ int gmx_grompp(int argc, char *argv[])
         "[THISMODULE] can be used to restart simulations (preserving",
         "continuity) by supplying just a checkpoint file with [TT]-t[tt].",
         "However, for simply changing the number of run steps to extend",
-        "a run, using [gmx-tpbconv] is more convenient than [THISMODULE].",
+        "a run, using [gmx-convert-tpr] is more convenient than [THISMODULE].",
         "You then supply the old checkpoint file directly to [gmx-mdrun]",
         "with [TT]-cpi[tt]. If you wish to change the ensemble or things",
         "like output frequency, then supplying the checkpoint file to",
index 3b22a25894abce6fa7e2e9256d72e85b0068372c..e7636519430eb899929ae50bf91642fb573a3f71 100644 (file)
@@ -50,7 +50,7 @@
 #include "../mdrun/mdrun_main.h"
 #include "gromacs/tools/check.h"
 #include "gromacs/tools/dump.h"
-#include "gromacs/tools/tpbconv.h"
+#include "gromacs/tools/convert_tpr.h"
 
 #include "legacycmainfunctions.h"
 
@@ -146,7 +146,7 @@ void registerLegacyModules(gmx::CommandLineModuleManager *manager)
                    "Make a run input file");
     registerModule(manager, &gmx_pdb2gmx, "pdb2gmx",
                    "Convert coordinate files to topology and FF-compliant coordinate files");
-    registerModule(manager, &gmx_tpbconv, "tpbconv",
+    registerModule(manager, &gmx_convert_tpr, "convert-tpr",
                    "Make a modifed run-input file");
 
     registerModule(manager, &gmx_protonate, "protonate",
@@ -346,7 +346,7 @@ void registerLegacyModules(gmx::CommandLineModuleManager *manager)
             manager->addModuleGroup("Running a simulation");
         group.addModule("grompp");
         group.addModule("mdrun");
-        group.addModule("tpbconv");
+        group.addModule("convert-tpr");
     }
     {
         gmx::CommandLineModuleGroup group =