Merge libgmxana into libgromacs.
authorTeemu Murtola <teemu.murtola@gmail.com>
Sun, 24 Mar 2013 13:49:31 +0000 (15:49 +0200)
committerTeemu Murtola <teemu.murtola@gmail.com>
Sun, 24 Mar 2013 18:28:07 +0000 (20:28 +0200)
- Move contents of src/tools/ into src/gromacs/gmxana/, except for
  g_tune_pme.c and g_pme_error.c.
- Delete unused src/tools/g_membed.c.
- Adjust the build system accordingly, removing references to gmxana.
- Merge contents of libgmxana.pc into libgromacs.pc and remove the
  former.
- Move src/gromacs/legacyheaders/gmx_ana.h into src/gromacs/gmxana/ and
  adjust files that include it accordingly.  Removed a few unnecessary
  inclusions of this header.  Don't install it, as it doesn't do much
  good.
- Merge src/contrib/g_sdf.c into src/contrib/gmx_sdf.c to make it
  independent of gmx_ana.h.  Remove gmx_sdf() from gmx_ana.h.

Closes #1013.

Change-Id: I34ba52fc938823833103123c8ada06d169abf7de

136 files changed:
src/contrib/g_sdf.c [deleted file]
src/contrib/gmx_sdf.c
src/gromacs/CMakeLists.txt
src/gromacs/gmxana/CMakeLists.txt [new file with mode: 0644]
src/gromacs/gmxana/addconf.c [moved from src/tools/addconf.c with 100% similarity]
src/gromacs/gmxana/addconf.h [moved from src/tools/addconf.h with 100% similarity]
src/gromacs/gmxana/anadih.c [moved from src/tools/anadih.c with 100% similarity]
src/gromacs/gmxana/autocorr.c [moved from src/tools/autocorr.c with 100% similarity]
src/gromacs/gmxana/binsearch.c [moved from src/tools/binsearch.c with 100% similarity]
src/gromacs/gmxana/binsearch.h [moved from src/tools/binsearch.h with 100% similarity]
src/gromacs/gmxana/calcpot.c [moved from src/tools/calcpot.c with 100% similarity]
src/gromacs/gmxana/calcpot.h [moved from src/tools/calcpot.h with 100% similarity]
src/gromacs/gmxana/cmat.c [moved from src/tools/cmat.c with 100% similarity]
src/gromacs/gmxana/cmat.h [moved from src/tools/cmat.h with 100% similarity]
src/gromacs/gmxana/correl.c [moved from src/tools/correl.c with 100% similarity]
src/gromacs/gmxana/correl.h [moved from src/tools/correl.h with 100% similarity]
src/gromacs/gmxana/dens_filter.c [moved from src/tools/dens_filter.c with 100% similarity]
src/gromacs/gmxana/dens_filter.h [moved from src/tools/dens_filter.h with 100% similarity]
src/gromacs/gmxana/dlist.c [moved from src/tools/dlist.c with 100% similarity]
src/gromacs/gmxana/edittop.c [moved from src/tools/edittop.c with 100% similarity]
src/gromacs/gmxana/eigio.c [moved from src/tools/eigio.c with 100% similarity]
src/gromacs/gmxana/eigio.h [moved from src/tools/eigio.h with 100% similarity]
src/gromacs/gmxana/expfit.c [moved from src/tools/expfit.c with 100% similarity]
src/gromacs/gmxana/fitahx.c [moved from src/tools/fitahx.c with 100% similarity]
src/gromacs/gmxana/fitahx.h [moved from src/tools/fitahx.h with 100% similarity]
src/gromacs/gmxana/geminate.c [moved from src/tools/geminate.c with 100% similarity]
src/gromacs/gmxana/geminate.h [moved from src/tools/geminate.h with 100% similarity]
src/gromacs/gmxana/gmx_ana.h [moved from src/gromacs/legacyheaders/gmx_ana.h with 99% similarity]
src/gromacs/gmxana/gmx_anadock.c [moved from src/tools/gmx_anadock.c with 100% similarity]
src/gromacs/gmxana/gmx_anaeig.c [moved from src/tools/gmx_anaeig.c with 100% similarity]
src/gromacs/gmxana/gmx_analyze.c [moved from src/tools/gmx_analyze.c with 100% similarity]
src/gromacs/gmxana/gmx_angle.c [moved from src/tools/gmx_angle.c with 100% similarity]
src/gromacs/gmxana/gmx_bar.c [moved from src/tools/gmx_bar.c with 100% similarity]
src/gromacs/gmxana/gmx_bond.c [moved from src/tools/gmx_bond.c with 100% similarity]
src/gromacs/gmxana/gmx_bundle.c [moved from src/tools/gmx_bundle.c with 100% similarity]
src/gromacs/gmxana/gmx_chi.c [moved from src/tools/gmx_chi.c with 100% similarity]
src/gromacs/gmxana/gmx_cluster.c [moved from src/tools/gmx_cluster.c with 100% similarity]
src/gromacs/gmxana/gmx_clustsize.c [moved from src/tools/gmx_clustsize.c with 100% similarity]
src/gromacs/gmxana/gmx_confrms.c [moved from src/tools/gmx_confrms.c with 100% similarity]
src/gromacs/gmxana/gmx_covar.c [moved from src/tools/gmx_covar.c with 100% similarity]
src/gromacs/gmxana/gmx_current.c [moved from src/tools/gmx_current.c with 100% similarity]
src/gromacs/gmxana/gmx_density.c [moved from src/tools/gmx_density.c with 100% similarity]
src/gromacs/gmxana/gmx_densmap.c [moved from src/tools/gmx_densmap.c with 100% similarity]
src/gromacs/gmxana/gmx_densorder.c [moved from src/tools/gmx_densorder.c with 100% similarity]
src/gromacs/gmxana/gmx_dielectric.c [moved from src/tools/gmx_dielectric.c with 100% similarity]
src/gromacs/gmxana/gmx_dipoles.c [moved from src/tools/gmx_dipoles.c with 100% similarity]
src/gromacs/gmxana/gmx_disre.c [moved from src/tools/gmx_disre.c with 100% similarity]
src/gromacs/gmxana/gmx_dist.c [moved from src/tools/gmx_dist.c with 100% similarity]
src/gromacs/gmxana/gmx_do_dssp.c [moved from src/tools/gmx_do_dssp.c with 100% similarity]
src/gromacs/gmxana/gmx_dos.c [moved from src/tools/gmx_dos.c with 100% similarity]
src/gromacs/gmxana/gmx_dyecoupl.c [moved from src/tools/gmx_dyecoupl.c with 100% similarity]
src/gromacs/gmxana/gmx_dyndom.c [moved from src/tools/gmx_dyndom.c with 100% similarity]
src/gromacs/gmxana/gmx_editconf.c [moved from src/tools/gmx_editconf.c with 100% similarity]
src/gromacs/gmxana/gmx_eneconv.c [moved from src/tools/gmx_eneconv.c with 100% similarity]
src/gromacs/gmxana/gmx_enemat.c [moved from src/tools/gmx_enemat.c with 100% similarity]
src/gromacs/gmxana/gmx_energy.c [moved from src/tools/gmx_energy.c with 100% similarity]
src/gromacs/gmxana/gmx_filter.c [moved from src/tools/gmx_filter.c with 100% similarity]
src/gromacs/gmxana/gmx_genbox.cpp [moved from src/tools/gmx_genbox.cpp with 100% similarity]
src/gromacs/gmxana/gmx_genconf.c [moved from src/tools/gmx_genconf.c with 100% similarity]
src/gromacs/gmxana/gmx_genion.c [moved from src/tools/gmx_genion.c with 100% similarity]
src/gromacs/gmxana/gmx_genpr.c [moved from src/tools/gmx_genpr.c with 100% similarity]
src/gromacs/gmxana/gmx_gyrate.c [moved from src/tools/gmx_gyrate.c with 100% similarity]
src/gromacs/gmxana/gmx_h2order.c [moved from src/tools/gmx_h2order.c with 100% similarity]
src/gromacs/gmxana/gmx_hbond.c [moved from src/tools/gmx_hbond.c with 100% similarity]
src/gromacs/gmxana/gmx_helix.c [moved from src/tools/gmx_helix.c with 100% similarity]
src/gromacs/gmxana/gmx_helixorient.c [moved from src/tools/gmx_helixorient.c with 100% similarity]
src/gromacs/gmxana/gmx_hydorder.c [moved from src/tools/gmx_hydorder.c with 100% similarity]
src/gromacs/gmxana/gmx_kinetics.c [moved from src/tools/gmx_kinetics.c with 100% similarity]
src/gromacs/gmxana/gmx_lie.c [moved from src/tools/gmx_lie.c with 100% similarity]
src/gromacs/gmxana/gmx_make_edi.c [moved from src/tools/gmx_make_edi.c with 100% similarity]
src/gromacs/gmxana/gmx_make_ndx.c [moved from src/tools/gmx_make_ndx.c with 100% similarity]
src/gromacs/gmxana/gmx_mdmat.c [moved from src/tools/gmx_mdmat.c with 100% similarity]
src/gromacs/gmxana/gmx_membed.c [moved from src/tools/gmx_membed.c with 100% similarity]
src/gromacs/gmxana/gmx_mindist.c [moved from src/tools/gmx_mindist.c with 100% similarity]
src/gromacs/gmxana/gmx_mk_angndx.c [moved from src/tools/gmx_mk_angndx.c with 100% similarity]
src/gromacs/gmxana/gmx_morph.c [moved from src/tools/gmx_morph.c with 100% similarity]
src/gromacs/gmxana/gmx_msd.c [moved from src/tools/gmx_msd.c with 100% similarity]
src/gromacs/gmxana/gmx_nmeig.c [moved from src/tools/gmx_nmeig.c with 100% similarity]
src/gromacs/gmxana/gmx_nmens.c [moved from src/tools/gmx_nmens.c with 100% similarity]
src/gromacs/gmxana/gmx_nmtraj.c [moved from src/tools/gmx_nmtraj.c with 100% similarity]
src/gromacs/gmxana/gmx_options.c [moved from src/tools/gmx_options.c with 100% similarity]
src/gromacs/gmxana/gmx_order.c [moved from src/tools/gmx_order.c with 100% similarity]
src/gromacs/gmxana/gmx_pme_error.c [moved from src/tools/gmx_pme_error.c with 100% similarity]
src/gromacs/gmxana/gmx_polystat.c [moved from src/tools/gmx_polystat.c with 100% similarity]
src/gromacs/gmxana/gmx_potential.c [moved from src/tools/gmx_potential.c with 100% similarity]
src/gromacs/gmxana/gmx_principal.c [moved from src/tools/gmx_principal.c with 100% similarity]
src/gromacs/gmxana/gmx_rama.c [moved from src/tools/gmx_rama.c with 100% similarity]
src/gromacs/gmxana/gmx_rdf.c [moved from src/tools/gmx_rdf.c with 100% similarity]
src/gromacs/gmxana/gmx_rms.c [moved from src/tools/gmx_rms.c with 100% similarity]
src/gromacs/gmxana/gmx_rmsdist.c [moved from src/tools/gmx_rmsdist.c with 100% similarity]
src/gromacs/gmxana/gmx_rmsf.c [moved from src/tools/gmx_rmsf.c with 100% similarity]
src/gromacs/gmxana/gmx_rotacf.c [moved from src/tools/gmx_rotacf.c with 100% similarity]
src/gromacs/gmxana/gmx_rotmat.c [moved from src/tools/gmx_rotmat.c with 100% similarity]
src/gromacs/gmxana/gmx_saltbr.c [moved from src/tools/gmx_saltbr.c with 100% similarity]
src/gromacs/gmxana/gmx_sans.c [moved from src/tools/gmx_sans.c with 100% similarity]
src/gromacs/gmxana/gmx_sas.c [moved from src/tools/gmx_sas.c with 100% similarity]
src/gromacs/gmxana/gmx_saxs.c [moved from src/tools/gmx_saxs.c with 100% similarity]
src/gromacs/gmxana/gmx_sgangle.c [moved from src/tools/gmx_sgangle.c with 100% similarity]
src/gromacs/gmxana/gmx_sham.c [moved from src/tools/gmx_sham.c with 100% similarity]
src/gromacs/gmxana/gmx_sigeps.c [moved from src/tools/gmx_sigeps.c with 100% similarity]
src/gromacs/gmxana/gmx_sorient.c [moved from src/tools/gmx_sorient.c with 100% similarity]
src/gromacs/gmxana/gmx_spatial.c [moved from src/tools/gmx_spatial.c with 100% similarity]
src/gromacs/gmxana/gmx_spol.c [moved from src/tools/gmx_spol.c with 100% similarity]
src/gromacs/gmxana/gmx_tcaf.c [moved from src/tools/gmx_tcaf.c with 100% similarity]
src/gromacs/gmxana/gmx_traj.c [moved from src/tools/gmx_traj.c with 100% similarity]
src/gromacs/gmxana/gmx_trjcat.c [moved from src/tools/gmx_trjcat.c with 100% similarity]
src/gromacs/gmxana/gmx_trjconv.c [moved from src/tools/gmx_trjconv.c with 100% similarity]
src/gromacs/gmxana/gmx_trjorder.c [moved from src/tools/gmx_trjorder.c with 100% similarity]
src/gromacs/gmxana/gmx_tune_pme.c [moved from src/tools/gmx_tune_pme.c with 100% similarity]
src/gromacs/gmxana/gmx_vanhove.c [moved from src/tools/gmx_vanhove.c with 100% similarity]
src/gromacs/gmxana/gmx_velacc.c [moved from src/tools/gmx_velacc.c with 100% similarity]
src/gromacs/gmxana/gmx_wham.cpp [moved from src/tools/gmx_wham.cpp with 100% similarity]
src/gromacs/gmxana/gmx_wheel.c [moved from src/tools/gmx_wheel.c with 100% similarity]
src/gromacs/gmxana/gmx_xpm2ps.c [moved from src/tools/gmx_xpm2ps.c with 100% similarity]
src/gromacs/gmxana/hxprops.c [moved from src/tools/hxprops.c with 100% similarity]
src/gromacs/gmxana/hxprops.h [moved from src/tools/hxprops.h with 100% similarity]
src/gromacs/gmxana/interf.h [moved from src/tools/interf.h with 100% similarity]
src/gromacs/gmxana/levenmar.c [moved from src/tools/levenmar.c with 100% similarity]
src/gromacs/gmxana/nsc.c [moved from src/tools/nsc.c with 100% similarity]
src/gromacs/gmxana/nsc.h [moved from src/tools/nsc.h with 100% similarity]
src/gromacs/gmxana/nsfactor.c [moved from src/tools/nsfactor.c with 100% similarity]
src/gromacs/gmxana/nsfactor.h [moved from src/tools/nsfactor.h with 100% similarity]
src/gromacs/gmxana/polynomials.c [moved from src/tools/polynomials.c with 100% similarity]
src/gromacs/gmxana/powerspect.c [moved from src/tools/powerspect.c with 100% similarity]
src/gromacs/gmxana/powerspect.h [moved from src/tools/powerspect.h with 100% similarity]
src/gromacs/gmxana/pp2shift.c [moved from src/tools/pp2shift.c with 100% similarity]
src/gromacs/gmxana/pp2shift.h [moved from src/tools/pp2shift.h with 100% similarity]
src/gromacs/gmxlib/sfactor.c
src/gromacs/libgromacs.pc.cmakein
src/programs/gmx/CMakeLists.txt
src/programs/gmx/legacymodules.cpp
src/tools/CMakeLists.txt
src/tools/g_membed.c [deleted file]
src/tools/g_pme_error.c
src/tools/g_tune_pme.c
src/tools/libgmxana.pc.cmakein [deleted file]

diff --git a/src/contrib/g_sdf.c b/src/contrib/g_sdf.c
deleted file mode 100644 (file)
index 1e020c4..0000000
+++ /dev/null
@@ -1,54 +0,0 @@
-/*
- * 
- *                This source code is part of
- * 
- *                 G   R   O   M   A   C   S
- * 
- *          GROningen MAchine for Chemical Simulations
- * 
- *                        VERSION 3.2.0
- * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
- * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
- * Copyright (c) 2001-2004, The GROMACS development team,
- * check out http://www.gromacs.org for more information.
-
- * This program is free software; you can redistribute it and/or
- * modify it under the terms of the GNU General Public License
- * as published by the Free Software Foundation; either version 2
- * of the License, or (at your option) any later version.
- * 
- * If you want to redistribute modifications, 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 www.gromacs.org.
- * 
- * To help us fund GROMACS development, we humbly ask that you cite
- * the papers on the package - you can find them in the top README file.
- * 
- * For more info, check our website at http://www.gromacs.org
- * 
- * And Hey:
- * Green Red Orange Magenta Azure Cyan Skyblue
- */
-#ifdef HAVE_CONFIG_H
-#include <config.h>
-#endif
-
-#include <gmx_ana.h>
-
-
-/* This is just a wrapper binary.
-* The code that used to be in g_sdf.c is now in gmx_sdf.c,
-* where the old main function is called gmx_sdf().
-*/
-int
-main(int argc, char *argv[])
-{
-  gmx_sdf(argc,argv);
-  return 0;
-}
-
-
-  
index 0a44beb2e3c862ba9cda362293dc1095e0735e50..88d7fe761fdd712229436638a44f76641f73c8de 100644 (file)
@@ -39,7 +39,6 @@
 #include "gstat.h"
 #include "matio.h"
 #include "gmx_fatal.h"
-#include "gmx_ana.h"
 
 
 #define G_REF1      0
@@ -768,3 +767,10 @@ int gmx_sdf(int argc,char *argv[])
   
   return 0;
 }
+
+int
+main(int argc, char *argv[])
+{
+  gmx_sdf(argc,argv);
+  return 0;
+}
index e38eec6cd5acfd34db50803ed827d21c9812f7a4..9703ca9b67777a3f6ff04a1a1ca4da1984f502b6 100644 (file)
@@ -1,7 +1,7 @@
 #
 # This file is part of the GROMACS molecular simulation package.
 #
-# Copyright (c) 2010,2011,2012, by the GROMACS development team, led by
+# Copyright (c) 2010,2011,2012,2013, by the GROMACS development team, led by
 # David van der Spoel, Berk Hess, Erik Lindahl, and including many
 # others, as listed in the AUTHORS file in the top-level source
 # directory and at http://www.gromacs.org.
@@ -38,6 +38,7 @@ add_subdirectory(legacyheaders)
 add_subdirectory(gmxlib)
 add_subdirectory(mdlib)
 add_subdirectory(gmxpreprocess)
+add_subdirectory(gmxana)
 add_subdirectory(analysisdata)
 add_subdirectory(commandline)
 add_subdirectory(linearalgebra)
@@ -104,7 +105,8 @@ if(GMX_BUILD_OWN_FFTW)
 endif()
 
 target_link_libraries(libgromacs ${GMX_GPU_LIBRARIES}
-                      ${GMX_EXTRA_LIBRARIES} ${FFT_LIBRARIES} ${XML_LIBRARIES}
+                      ${GMX_EXTRA_LIBRARIES}
+                      ${FFT_LIBRARIES} ${XML_LIBRARIES} ${GSL_LIBRARIES}
                       ${THREAD_LIB} ${GMX_SHARED_LINKER_FLAGS})
 set_target_properties(libgromacs PROPERTIES
                       OUTPUT_NAME "gromacs${GMX_LIBS_SUFFIX}"
diff --git a/src/gromacs/gmxana/CMakeLists.txt b/src/gromacs/gmxana/CMakeLists.txt
new file mode 100644 (file)
index 0000000..89a289c
--- /dev/null
@@ -0,0 +1,37 @@
+#
+# This file is part of the GROMACS molecular simulation package.
+#
+# Copyright (c) 2013, by the GROMACS development team, led by
+# David van der Spoel, Berk Hess, 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.
+
+file(GLOB GMXANA_SOURCES *.c *.cpp)
+
+set(LIBGROMACS_SOURCES ${LIBGROMACS_SOURCES} ${GMXANA_SOURCES} PARENT_SCOPE)
similarity index 100%
rename from src/tools/cmat.c
rename to src/gromacs/gmxana/cmat.c
similarity index 100%
rename from src/tools/cmat.h
rename to src/gromacs/gmxana/cmat.h
similarity index 100%
rename from src/tools/dlist.c
rename to src/gromacs/gmxana/dlist.c
similarity index 100%
rename from src/tools/eigio.c
rename to src/gromacs/gmxana/eigio.c
similarity index 100%
rename from src/tools/eigio.h
rename to src/gromacs/gmxana/eigio.h
similarity index 99%
rename from src/gromacs/legacyheaders/gmx_ana.h
rename to src/gromacs/gmxana/gmx_ana.h
index 062fc9752703811ddec6835c31525b3dde183033..27f54d6b8efaa32ff72c587b4ac0565150133dba 100644 (file)
@@ -225,9 +225,6 @@ gmx_saltbr(int argc, char *argv[]);
 int
 gmx_sas(int argc, char *argv[]);
 
-int
-gmx_sdf(int argc, char *argv[]);
-
 int
 gmx_select(int argc, char *argv[]);
 
similarity index 100%
rename from src/tools/nsc.c
rename to src/gromacs/gmxana/nsc.c
similarity index 100%
rename from src/tools/nsc.h
rename to src/gromacs/gmxana/nsc.h
index 5ec013c64fa44d1aee051a0ed879f365a17332ad..7d7b1636bf2c938eb8c2a569fe396507f17e8f7d 100644 (file)
@@ -55,7 +55,6 @@
 #include "gmxfio.h"
 #include "xvgr.h"
 #include "matio.h"
-#include "gmx_ana.h"
 #include "names.h"
 #include "sfactor.h"
 
index d059a34767e004920a3d2a799b1a20f22863dfd9..5cc1da7b318dbab3381d50a4178d99e02d4fc012 100644 (file)
@@ -5,7 +5,7 @@ Name: libgromacs
 Description: Gromacs library
 URL: http://www.gromacs.org
 Version: @PROJECT_VERSION@
-Requires: @PKG_FFT@ @PKG_XML@
+Requires: @PKG_FFT@ @PKG_XML@ @PKG_GSL@
 Libs.private: @CMAKE_THREAD_LIBS_INIT@ @PKG_DL_LIBS@ @OpenMP_LINKER_FLAGS@
 Libs: -L${libdir} -lgromacs@GMX_LIBS_SUFFIX@ @PKG_FFT_LIBS@ -lm
 Cflags: -I${includedir} @PKG_CFLAGS@
index be3c495e758a76ac68810cda45660192c221ed3c..edaaef66bf73ff177c3f60c38765ca302c147865 100644 (file)
@@ -33,7 +33,7 @@
 # the research papers on the package. Check out http://www.gromacs.org.
 
 add_executable(gmx gmx.cpp legacymodules.cpp)
-target_link_libraries(gmx libgromacs gmxana ${GMX_EXE_LINKER_FLAGS})
+target_link_libraries(gmx libgromacs ${GMX_EXE_LINKER_FLAGS})
 set_target_properties(gmx PROPERTIES OUTPUT_NAME "gmx${GMX_BINARY_SUFFIX}")
 
 configure_file(CreateLinks.cmake.cmakein CreateLinks.cmake @ONLY)
index cf20a6494db46933cc55cbd29a523c107fa1729e..0a3c2b694aed4b51b31bb6e4f364cc8473d8fdbd 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013, by the GROMACS development team, led by
  * David van der Spoel, Berk Hess, Erik Lindahl, and including many
  * others, as listed in the AUTHORS file in the top-level source
  * directory and at http://www.gromacs.org.
@@ -44,7 +44,7 @@
 #include "gromacs/onlinehelp/helpwritercontext.h"
 #include "gromacs/utility/exceptions.h"
 
-#include "gromacs/legacyheaders/gmx_ana.h"
+#include "gromacs/gmxana/gmx_ana.h"
 
 namespace
 {
index 578c640bb4f7a4ba0e621150bd28e909f3e52c77..106e88ad0343cf13be5fce83beb57facace7092a 100644 (file)
@@ -1,44 +1,3 @@
-add_library(gmxana 
-            autocorr.c      expfit.c        polynomials.c   levenmar.c      
-            anadih.c        pp2shift.c      dlist.c         
-            eigio.c         cmat.c          nsc.c
-            hxprops.c       fitahx.c        
-            geminate.c      nsfactor.c
-            gmx_analyze.c   gmx_anaeig.c    gmx_angle.c     gmx_bond.c      
-            gmx_bundle.c    gmx_chi.c       gmx_cluster.c   gmx_confrms.c   
-            gmx_covar.c     gmx_current.c   
-            gmx_density.c   gmx_densmap.c       
-            gmx_dielectric.c        
-            gmx_kinetics.c  gmx_spatial.c   gmx_tune_pme.c
-            gmx_dipoles.c   gmx_disre.c     gmx_dist.c      gmx_dyndom.c    
-            gmx_enemat.c    gmx_energy.c    gmx_lie.c       gmx_filter.c    
-            gmx_gyrate.c    gmx_h2order.c   gmx_hbond.c     gmx_helix.c     
-            gmx_mindist.c   gmx_msd.c       gmx_morph.c     gmx_nmeig.c     
-            gmx_nmens.c     gmx_order.c     gmx_principal.c 
-            gmx_polystat.c  gmx_potential.c gmx_rama.c      
-            gmx_rdf.c       gmx_rms.c       gmx_rmsf.c      
-            gmx_rotacf.c    gmx_saltbr.c    gmx_sas.c       gmx_sans.c
-            gmx_rmsdist.c   gmx_rotmat.c
-            gmx_sgangle.c   gmx_sorient.c   gmx_spol.c      gmx_tcaf.c      
-            gmx_traj.c      gmx_velacc.c    gmx_helixorient.c 
-            gmx_clustsize.c gmx_mdmat.c     gmx_wham.cpp
-            correl.c        gmx_sham.c      gmx_nmtraj.c    
-            gmx_trjconv.c   gmx_trjcat.c    gmx_trjorder.c  gmx_xpm2ps.c    
-            gmx_editconf.c  gmx_genbox.cpp    gmx_genion.c    gmx_genconf.c
-            gmx_genpr.c     gmx_eneconv.c   gmx_vanhove.c   gmx_wheel.c     
-            addconf.c       calcpot.c       edittop.c       gmx_bar.c
-            gmx_pme_error.c gmx_options.c   gmx_dos.c
-            gmx_hydorder.c  gmx_densorder.c powerspect.c    dens_filter.c
-            binsearch.c     gmx_dyecoupl.c  gmx_make_edi.c  gmx_sigeps.c
-            gmx_do_dssp.c   gmx_anadock.c   gmx_make_ndx.c  gmx_mk_angndx.c
-           gmx_saxs.c
-            )
-
-
-target_link_libraries(gmxana libgromacs ${GSL_LIBRARIES} ${GMX_SHARED_LINKER_FLAGS})
-set_target_properties(gmxana PROPERTIES OUTPUT_NAME "gmxana${GMX_LIBS_SUFFIX}" SOVERSION ${SOVERSION}
-    COMPILE_FLAGS "${OpenMP_C_FLAGS}")
-
 # List of programs with single corresponding .c source file,
 # used to create build rules automatically.
 #
@@ -46,26 +5,13 @@ set(GMX_TOOLS_PROGRAMS
     g_tune_pme g_pme_error
     )
 
-set(GMX_TOOLS_PROGRAMS_NOT_FOR_INSTALLATION
-  # names of any executables that should be built but not installed can go here
-    )
-
-
-foreach(TOOL ${GMX_TOOLS_PROGRAMS} ${GMX_TOOLS_PROGRAMS_NOT_FOR_INSTALLATION})
+foreach(TOOL ${GMX_TOOLS_PROGRAMS})
     add_executable(${TOOL} ${TOOL}.c)
     gmx_add_man_page(${TOOL})
-    target_link_libraries(${TOOL} gmxana ${GMX_EXE_LINKER_FLAGS})
+    target_link_libraries(${TOOL} libgromacs ${GMX_EXE_LINKER_FLAGS})
     set_target_properties(${TOOL} PROPERTIES OUTPUT_NAME "${TOOL}${GMX_BINARY_SUFFIX}")
-endforeach(TOOL ${GMX_TOOLS_PROGRAMS}) 
+endforeach(TOOL ${GMX_TOOLS_PROGRAMS})
 
-
-install(TARGETS gmxana DESTINATION ${LIB_INSTALL_DIR} COMPONENT runtime)
 install(TARGETS ${GMX_TOOLS_PROGRAMS}
         DESTINATION ${BIN_INSTALL_DIR}
         COMPONENT runtime)
-
-configure_file(${CMAKE_CURRENT_SOURCE_DIR}/libgmxana.pc.cmakein ${CMAKE_CURRENT_BINARY_DIR}/libgmxana.pc @ONLY)
-install(FILES ${CMAKE_CURRENT_BINARY_DIR}/libgmxana.pc
-        DESTINATION ${LIB_INSTALL_DIR}/pkgconfig
-        RENAME "libgmxana${GMX_LIBS_SUFFIX}.pc"
-        COMPONENT development)
diff --git a/src/tools/g_membed.c b/src/tools/g_membed.c
deleted file mode 100644 (file)
index d9bd19e..0000000
+++ /dev/null
@@ -1,51 +0,0 @@
-/*
- *
- *                This source code is part of
- *
- *                 G   R   O   M   A   C   S
- *
- *          GROningen MAchine for Chemical Simulations
- *
- *                        VERSION 4.0.3
- * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
- * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
- * Copyright (c) 2001-2004, The GROMACS development team,
- * check out http://www.gromacs.org for more information.
-
- * This program is free software; you can redistribute it and/or
- * modify it under the terms of the GNU General Public License
- * as published by the Free Software Foundation; either version 2
- * of the License, or (at your option) any later version.
- *
- * If you want to redistribute modifications, 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 www.gromacs.org.
- *
- * To help us fund GROMACS development, we humbly ask that you cite
- * the papers on the package - you can find them in the top README file.
- *
- * For more info, check our website at http://www.gromacs.org
- *
- * And Hey:
- * Green Red Orange Magenta Azure Cyan Skyblue
- */
-#ifdef HAVE_CONFIG_H
-#include <config.h>
-#endif
-
-#include <gmx_ana.h>
-
-
-/* This is just a wrapper binary.
- * The code that used to be in g_anaeig.c is now in gmx_anaeig.c,
- * where the old main function is called gmx_anaeig().
- */
-int
-main(int argc, char *argv[])
-{
-    gmx_membed(argc, argv);
-    return 0;
-}
index 48c12a3661137297638ba8698438718ce4c3fefc..6249737ed2f95402faa81f3008b88cc5ceabf14f 100644 (file)
  * And Hey:
  * Gallium Rubidium Oxygen Manganese Argon Carbon Silicon
  */
-
-#ifdef HAVE_CONFIG_H
-#include <config.h>
-#endif
-
-#include <gmx_ana.h>
-
+#include "gromacs/gmxana/gmx_ana.h"
 
 /* This is just a wrapper binary.
  */
index 2fc4e012a8db006ef37935d2e8539214d0b2634d..ab68d58791fe214026dcc067bab0c06b38e3d294 100644 (file)
  * And Hey:
  * Gallium Rubidium Oxygen Manganese Argon Carbon Silicon
  */
-
-#ifdef HAVE_CONFIG_H
-#include <config.h>
-#endif
-
-#include <gmx_ana.h>
-
+#include "gromacs/gmxana/gmx_ana.h"
 
 /* This is just a wrapper binary.
  */
diff --git a/src/tools/libgmxana.pc.cmakein b/src/tools/libgmxana.pc.cmakein
deleted file mode 100644 (file)
index 16b8850..0000000
+++ /dev/null
@@ -1,12 +0,0 @@
-libdir=@LIB_INSTALL_DIR@
-includedir=@INCL_INSTALL_DIR@
-
-Name: libgmxana
-Description: Gromacs analysis lib
-URL: http://www.gromacs.org
-Version: @PROJECT_VERSION@
-Requires: @PKG_GSL@ libgromacs@GMX_LIBS_SUFFIX@
-Libs.private: -lm @CMAKE_THREAD_LIBS_INIT@
-Libs: -L${libdir} -lgmxana@GMX_LIBS_SUFFIX@
-Cflags: -I${includedir} @PKG_CFLAGS@
-