Move more tools out of gmxana
authorKevin Boyd <kevin.boyd@uconn.edu>
Fri, 18 Jan 2019 14:11:47 +0000 (09:11 -0500)
committerKevin Boyd <kevin.boyd@uconn.edu>
Wed, 3 Jul 2019 01:28:35 +0000 (03:28 +0200)
Moved some files to simulationdatabase and updated references to them

refs #2727

Change-Id: Idf8375b672fbb6e4676fa22b9eb9c33d1b347166

29 files changed:
src/gromacs/fileio/tests/tngio.cpp
src/gromacs/gmxana/gmx_ana.h
src/gromacs/gmxana/tests/CMakeLists.txt
src/gromacs/gmxana/tests/gmx_traj.cpp
src/gromacs/gmxana/tests/spc2.gro [deleted file]
src/gromacs/gmxana/tests/spc2.ndx [deleted file]
src/gromacs/tools/eneconv.cpp [moved from src/gromacs/gmxana/gmx_eneconv.cpp with 99% similarity]
src/gromacs/tools/eneconv.h [new file with mode: 0644]
src/gromacs/tools/make_ndx.cpp [moved from src/gromacs/gmxana/gmx_make_ndx.cpp with 99% similarity]
src/gromacs/tools/make_ndx.h [new file with mode: 0644]
src/gromacs/tools/mk_angndx.cpp [moved from src/gromacs/gmxana/gmx_mk_angndx.cpp with 98% similarity]
src/gromacs/tools/mk_angndx.h [new file with mode: 0644]
src/gromacs/tools/pme_error.cpp [moved from src/gromacs/gmxana/gmx_pme_error.cpp with 99% similarity]
src/gromacs/tools/pme_error.h [new file with mode: 0644]
src/gromacs/tools/tests/CMakeLists.txt
src/gromacs/tools/tests/trjconv.cpp [moved from src/gromacs/gmxana/tests/gmx_trjconv.cpp with 96% similarity]
src/gromacs/tools/trjcat.cpp [moved from src/gromacs/gmxana/gmx_trjcat.cpp with 99% similarity]
src/gromacs/tools/trjcat.h [new file with mode: 0644]
src/gromacs/tools/trjconv.cpp [moved from src/gromacs/gmxana/gmx_trjconv.cpp with 99% similarity]
src/gromacs/tools/trjconv.h [new file with mode: 0644]
src/gromacs/tools/tune_pme.cpp [moved from src/gromacs/gmxana/gmx_tune_pme.cpp with 99% similarity]
src/gromacs/tools/tune_pme.h [new file with mode: 0644]
src/programs/legacymodules.cpp
src/testutils/simulationdatabase/spc2-traj.g96 [moved from src/gromacs/gmxana/tests/spc2-traj.g96 with 100% similarity]
src/testutils/simulationdatabase/spc2-traj.gro [moved from src/gromacs/gmxana/tests/spc2-traj.gro with 100% similarity]
src/testutils/simulationdatabase/spc2-traj.pdb [moved from src/gromacs/gmxana/tests/spc2-traj.pdb with 100% similarity]
src/testutils/simulationdatabase/spc2-traj.tng [moved from src/gromacs/gmxana/tests/spc2-traj.tng with 100% similarity]
src/testutils/simulationdatabase/spc2-traj.trr [moved from src/gromacs/gmxana/tests/spc2-traj.trr with 100% similarity]
src/testutils/simulationdatabase/spc2-traj.xtc [moved from src/gromacs/gmxana/tests/spc2-traj.xtc with 100% similarity]

index 77ca67b5737f3386b1167468b24e632b7d3b6bb8..0ea66b141405fe5b46760f567443261e0f45b228 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2013,2014,2016,2017,2018, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2016,2017,2018,2019, 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.
@@ -49,6 +49,7 @@
 
 #include "gromacs/utility/path.h"
 
+#include "testutils/simulationdatabase.h"
 #include "testutils/testfilemanager.h"
 
 namespace
@@ -66,9 +67,7 @@ class TngTest : public ::testing::Test
 TEST_F(TngTest, CanOpenTngFile)
 {
     gmx_tng_trajectory_t tng;
-    gmx_tng_open(gmx::test::TestFileManager::getInputFilePath("spc2-traj.tng").c_str(),
-                 'r',
-                 &tng);
+    gmx_tng_open("spc2-traj.tng", 'r', &tng);
     gmx_tng_close(&tng);
 }
 
index 756865dc5cae80efe6161562b5250922d7272391..3e62f32d54d3d30b745c9c8db1c6950506aa2962 100644 (file)
@@ -98,9 +98,6 @@ gmx_dos(int argc, char *argv[]);
 int
 gmx_dyecoupl(int argc, char *argv[]);
 
-int
-gmx_eneconv(int argc, char *argv[]);
-
 int
 gmx_enemat(int argc, char *argv[]);
 
@@ -134,15 +131,9 @@ gmx_hydorder(int argc, char *argv[]);
 int
 gmx_make_edi(int argc, char *argv[]);
 
-int
-gmx_make_ndx(int argc, char *argv[]);
-
 int
 gmx_mindist(int argc, char *argv[]);
 
-int
-gmx_mk_angndx(int argc, char *argv[]);
-
 int
 gmx_msd(int argc, char *argv[]);
 
@@ -212,18 +203,9 @@ gmx_tcaf(int argc, char *argv[]);
 int
 gmx_traj(int argc, char *argv[]);
 
-int
-gmx_trjcat(int argc, char *argv[]);
-
-int
-gmx_trjconv(int argc, char *argv[]);
-
 int
 gmx_trjorder(int argc, char *argv[]);
 
-int
-gmx_tune_pme(int argc, char *argv[]);
-
 int
 gmx_velacc(int argc, char *argv[]);
 
@@ -248,9 +230,6 @@ gmx_xpm2ps(int argc, char *argv[]);
 int
 gmx_membed(int argc, char *argv[]);
 
-int
-gmx_pme_error(int argc, char *argv[]);
-
 int
 gmx_sans(int argc, char *argv[]);
 
index 846e6aeb553f4a45b889d8050542ad0ac9111bea..47dfa35da94160fd7a6148d4688d46ea5a295e4e 100644 (file)
@@ -38,8 +38,6 @@ gmx_add_gtest_executable(
     ${exename}
     entropy.cpp
     gmx_traj.cpp
-    gmx_trjconv.cpp
-    gmx_make_ndx.cpp
     gmx_mindist.cpp
     gmx_msd.cpp
     )
index 1f6c2669133c474cc0083dc70225dc0bea5fcad4..9bf8b93a2a4f1aad2e205899800a208db4d8225b 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2013,2014,2016,2017,2018, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2016,2017,2018,2019, 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.
@@ -45,6 +45,7 @@
 #include "gromacs/gmxana/gmx_ana.h"
 
 #include "testutils/cmdlinetest.h"
+#include "testutils/simulationdatabase.h"
 #include "testutils/stdiohelper.h"
 #include "testutils/textblockmatchers.h"
 
diff --git a/src/gromacs/gmxana/tests/spc2.gro b/src/gromacs/gmxana/tests/spc2.gro
deleted file mode 100644 (file)
index 9ed6192..0000000
+++ /dev/null
@@ -1,9 +0,0 @@
-
- 6
-    1SOL     OW    1   0.569   1.275   1.165   0.569   1.215   1.965
-    1SOL    HW1    2   0.476   1.268   1.128   0.669   1.225   1.865
-    1SOL    HW2    3   0.580   1.364   1.209   0.769   1.235   1.765
-    2SOL     OW    4   1.555   1.511   0.703   0.869   1.245   1.665
-    2SOL    HW1    5   1.498   1.495   0.784   0.169   0.275   1.565
-    2SOL    HW2    6   1.496   1.521   0.623   0.269   2.275   1.465
-   3.01000   3.01000   3.01000
diff --git a/src/gromacs/gmxana/tests/spc2.ndx b/src/gromacs/gmxana/tests/spc2.ndx
deleted file mode 100644 (file)
index 78e537a..0000000
+++ /dev/null
@@ -1,6 +0,0 @@
-[ System ]
-   1    2    3    4    5   6
-[ FirstWaterMolecule ]
-   1    2    3
-[ SecondWaterMolecule ]
-   4    5    6
similarity index 99%
rename from src/gromacs/gmxana/gmx_eneconv.cpp
rename to src/gromacs/tools/eneconv.cpp
index 394c343fb9fb3b0336aca797fc9d4dc4455dbfc8..c76e4b9eb242907804d37b872342c05807b34e69 100644 (file)
@@ -36,6 +36,8 @@
  */
 #include "gmxpre.h"
 
+#include "eneconv.h"
+
 #include <cmath>
 #include <cstdlib>
 #include <cstring>
@@ -45,7 +47,6 @@
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/enxio.h"
 #include "gromacs/fileio/trxio.h"
-#include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/listed_forces/disre.h"
 #include "gromacs/math/functions.h"
 #include "gromacs/math/vec.h"
diff --git a/src/gromacs/tools/eneconv.h b/src/gromacs/tools/eneconv.h
new file mode 100644 (file)
index 0000000..b0cbb97
--- /dev/null
@@ -0,0 +1,45 @@
+/*
+ * This file is part of the GROMACS molecular simulation package.
+ *
+ * Copyright (c) 2019, 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_TOOLS_ENECONV_H
+#define GMX_TOOLS_ENECONV_H
+
+/*! \brief Implements gmx eneconv
+ *
+ * \param[in] argc  argc value passed to main().
+ * \param[in] argv  argv array passed to main().
+ */
+int gmx_eneconv(int argc, char *argv[]);
+
+#endif
similarity index 99%
rename from src/gromacs/gmxana/gmx_make_ndx.cpp
rename to src/gromacs/tools/make_ndx.cpp
index 12310fb33006843a3d7775021024fd76c21f313d..a3758b259a5feceddceb5a87b318f31b9eeb9154 100644 (file)
@@ -36,6 +36,8 @@
  */
 #include "gmxpre.h"
 
+#include "make_ndx.h"
+
 #include <cctype>
 #include <cstring>
 
@@ -43,7 +45,6 @@
 
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/confio.h"
-#include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/topology/block.h"
 #include "gromacs/topology/index.h"
diff --git a/src/gromacs/tools/make_ndx.h b/src/gromacs/tools/make_ndx.h
new file mode 100644 (file)
index 0000000..7ae7c49
--- /dev/null
@@ -0,0 +1,45 @@
+/*
+ * This file is part of the GROMACS molecular simulation package.
+ *
+ * Copyright (c) 2019, 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_TOOLS_MAKE_NDX_H
+#define GMX_TOOLS_MAKE_NDX_H
+
+/*! \brief Implements gmx make_ndx
+ *
+ * \param[in] argc  argc value passed to main().
+ * \param[in] argv  argv array passed to main().
+ */
+int gmx_make_ndx(int argc, char *argv[]);
+
+#endif
similarity index 98%
rename from src/gromacs/gmxana/gmx_mk_angndx.cpp
rename to src/gromacs/tools/mk_angndx.cpp
index eee7ec8bbd85c17836f9ddb283cbb7d5b87927cb..0f59fee73a332aa8c6d526a50977d888f76cc3f7 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) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018,2019, 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.
  */
 #include "gmxpre.h"
 
+#include "mk_angndx.h"
+
 #include <cmath>
 
 #include "gromacs/commandline/pargs.h"
 #include "gromacs/fileio/trxio.h"
-#include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/topology/ifunc.h"
 #include "gromacs/topology/topology.h"
 #include "gromacs/utility/arraysize.h"
diff --git a/src/gromacs/tools/mk_angndx.h b/src/gromacs/tools/mk_angndx.h
new file mode 100644 (file)
index 0000000..86000dd
--- /dev/null
@@ -0,0 +1,45 @@
+/*
+ * This file is part of the GROMACS molecular simulation package.
+ *
+ * Copyright (c) 2019, 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_TOOLS_MK_ANGNDX_H
+#define GMX_TOOLS_MK_ANGNDX_H
+
+/*! \brief Implements gmx mk_angndx
+ *
+ * \param[in] argc  argc value passed to main().
+ * \param[in] argv  argv array passed to main().
+ */
+int gmx_mk_angndx(int argc, char *argv[]);
+
+#endif
similarity index 99%
rename from src/gromacs/gmxana/gmx_pme_error.cpp
rename to src/gromacs/tools/pme_error.cpp
index bc87405672b5aa3ecc18c77868c98a56411a0fcf..781b7b99cb3c4670fec1485e0d6a56bf3ac34b58 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2010,2011,2012,2013,2014,2015,2016,2017,2018,2019, by the GROMACS development team, led by
+ * Copyright (c) 2010,2011,2012,2013,2014,2015,2016,2017,2018,2019,2019, 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.
@@ -34,6 +34,8 @@
  */
 #include "gmxpre.h"
 
+#include "pme_error.h"
+
 #include "config.h"
 
 #include <cmath>
@@ -46,7 +48,6 @@
 #include "gromacs/fft/calcgrid.h"
 #include "gromacs/fileio/checkpoint.h"
 #include "gromacs/fileio/tpxio.h"
-#include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/gmxlib/network.h"
 #include "gromacs/math/functions.h"
 #include "gromacs/math/units.h"
diff --git a/src/gromacs/tools/pme_error.h b/src/gromacs/tools/pme_error.h
new file mode 100644 (file)
index 0000000..19a30d5
--- /dev/null
@@ -0,0 +1,45 @@
+/*
+ * This file is part of the GROMACS molecular simulation package.
+ *
+ * Copyright (c) 2019, 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_TOOLS_PME_ERROR_H
+#define GMX_TOOLS_PME_ERROR_H
+
+/*! \brief Implements gmx pme_error
+ *
+ * \param[in] argc  argc value passed to main().
+ * \param[in] argv  argv array passed to main().
+ */
+int gmx_pme_error(int argc, char *argv[]);
+
+#endif
index db4d21b3d9e827974c00a7c3e558196a213cbcce..6796538f7cda0fc23eae5e0988a228af720ae324 100644 (file)
@@ -34,5 +34,6 @@
 
 gmx_add_unit_test(ToolUnitTests tool-test
                   dump.cpp
-                  report_methods.cpp)
+                  report_methods.cpp
+                  trjconv.cpp)
 
similarity index 96%
rename from src/gromacs/gmxana/tests/gmx_trjconv.cpp
rename to src/gromacs/tools/tests/trjconv.cpp
index 49a8a1dad696826997646a6f59a98723a7e9a958..b73c01f85d805698ff9b5b6dad35cd93fb28d5b6 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2013,2014,2016,2017,2018, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2016,2017,2018,2019, 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.
  */
 #include "gmxpre.h"
 
-#include "config.h"
+#include "gromacs/tools/trjconv.h"
 
-#include "gromacs/gmxana/gmx_ana.h"
+#include "config.h"
 
 #include "testutils/cmdlinetest.h"
+#include "testutils/simulationdatabase.h"
 #include "testutils/stdiohelper.h"
 #include "testutils/textblockmatchers.h"
 
similarity index 99%
rename from src/gromacs/gmxana/gmx_trjcat.cpp
rename to src/gromacs/tools/trjcat.cpp
index 0b11af8b86749cc046702b16c8fd0b8490b3ab19..781608e3d7359dc25084adf453a2a8a0538ec944 100644 (file)
@@ -36,6 +36,8 @@
  */
 #include "gmxpre.h"
 
+#include "trjcat.h"
+
 #include <cmath>
 #include <cstdlib>
 #include <cstring>
@@ -51,7 +53,6 @@
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xtcio.h"
 #include "gromacs/fileio/xvgr.h"
-#include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/mdtypes/md_enums.h"
 #include "gromacs/topology/index.h"
diff --git a/src/gromacs/tools/trjcat.h b/src/gromacs/tools/trjcat.h
new file mode 100644 (file)
index 0000000..5cd756a
--- /dev/null
@@ -0,0 +1,45 @@
+/*
+ * This file is part of the GROMACS molecular simulation package.
+ *
+ * Copyright (c) 2019, 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_TOOLS_TRJCAT_H
+#define GMX_TOOLS_TRJCAT_H
+
+/*! \brief Implements gmx trjcat
+ *
+ * \param[in] argc  argc value passed to main().
+ * \param[in] argv  argv array passed to main().
+ */
+int gmx_trjcat(int argc, char *argv[]);
+
+#endif
similarity index 99%
rename from src/gromacs/gmxana/gmx_trjconv.cpp
rename to src/gromacs/tools/trjconv.cpp
index d18edaa98c9320e2383af9d729cdfd6f8d2a9b61..d21cdfabe6b8a239b2ece2066db9c32bbe8ed0e3 100644 (file)
@@ -36,6 +36,8 @@
  */
 #include "gmxpre.h"
 
+#include "trjconv.h"
+
 #include <cmath>
 #include <cstdlib>
 #include <cstring>
@@ -56,7 +58,6 @@
 #include "gromacs/fileio/trxio.h"
 #include "gromacs/fileio/xtcio.h"
 #include "gromacs/fileio/xvgr.h"
-#include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/math/do_fit.h"
 #include "gromacs/math/functions.h"
 #include "gromacs/math/vec.h"
diff --git a/src/gromacs/tools/trjconv.h b/src/gromacs/tools/trjconv.h
new file mode 100644 (file)
index 0000000..de74074
--- /dev/null
@@ -0,0 +1,45 @@
+/*
+ * This file is part of the GROMACS molecular simulation package.
+ *
+ * Copyright (c) 2019, 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_TOOLS_TRJCONV_H
+#define GMX_TOOLS_TRJCONV_H
+
+/*! \brief Implements gmx trjconv
+ *
+ * \param[in] argc  argc value passed to main().
+ * \param[in] argv  argv array passed to main().
+ */
+int gmx_trjconv(int argc, char *argv[]);
+
+#endif
similarity index 99%
rename from src/gromacs/gmxana/gmx_tune_pme.cpp
rename to src/gromacs/tools/tune_pme.cpp
index 0c6abc61da73aa17cbd5019535745a3a02524f59..4663f6f516762fc3ac0c491f939cbc081f4d0e10 100644 (file)
@@ -34,6 +34,8 @@
  */
 #include "gmxpre.h"
 
+#include "tune_pme.h"
+
 #include "config.h"
 
 #include <cmath>
@@ -53,7 +55,6 @@
 #include "gromacs/fft/calcgrid.h"
 #include "gromacs/fileio/checkpoint.h"
 #include "gromacs/fileio/tpxio.h"
-#include "gromacs/gmxana/gmx_ana.h"
 #include "gromacs/math/utilities.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/mdlib/perf_est.h"
diff --git a/src/gromacs/tools/tune_pme.h b/src/gromacs/tools/tune_pme.h
new file mode 100644 (file)
index 0000000..ec4da7d
--- /dev/null
@@ -0,0 +1,45 @@
+/*
+ * This file is part of the GROMACS molecular simulation package.
+ *
+ * Copyright (c) 2019, 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_TOOLS_TUNE_PME_H
+#define GMX_TOOLS_TUNE_PME_H
+
+/*! \brief Implements gmx tune_pme
+ *
+ * \param[in] argc  argc value passed to main().
+ * \param[in] argv  argv array passed to main().
+ */
+int gmx_tune_pme(int argc, char *argv[]);
+
+#endif
index 76dc0d98ee41ff2024a9d54a82d600679c6e6173..b8ec65eaa0456609451f8c402aec2544e4a8f9ff 100644 (file)
 #include "gromacs/tools/check.h"
 #include "gromacs/tools/convert_tpr.h"
 #include "gromacs/tools/dump.h"
+#include "gromacs/tools/eneconv.h"
+#include "gromacs/tools/make_ndx.h"
+#include "gromacs/tools/mk_angndx.h"
+#include "gromacs/tools/pme_error.h"
 #include "gromacs/tools/report_methods.h"
+#include "gromacs/tools/trjcat.h"
+#include "gromacs/tools/trjconv.h"
+#include "gromacs/tools/tune_pme.h"
 
 #include "mdrun/mdrun_main.h"
 #include "view/view.h"