Remove unnecessary config.h includes
authorTeemu Murtola <teemu.murtola@gmail.com>
Tue, 19 Aug 2014 03:38:10 +0000 (06:38 +0300)
committerTeemu Murtola <teemu.murtola@gmail.com>
Fri, 5 Sep 2014 19:00:07 +0000 (22:00 +0300)
Now that all the blanket definitions that need to appear everywhere are
in gmxpre.h, remove unnecessary uses of config.h.  Kernel files left
alone for now.

Change-Id: I1e0e7b1f842c5182334687ad86afaee176e31bf2

271 files changed:
src/gromacs/commandline/pargs.cpp
src/gromacs/essentialdynamics/edsam.c
src/gromacs/fft/fft_fftpack.c
src/gromacs/fft/fft_mkl.c
src/gromacs/fft/parallel_3dfft.c
src/gromacs/fileio/confio.c
src/gromacs/fileio/enxio.c
src/gromacs/fileio/filenm.c
src/gromacs/fileio/libxdrf.c
src/gromacs/fileio/matio.cpp
src/gromacs/fileio/mtxio.c
src/gromacs/fileio/pdbio.c
src/gromacs/fileio/strdb.c
src/gromacs/fileio/timecontrol.c
src/gromacs/fileio/tpxio.c
src/gromacs/fileio/trajectory_writing.c
src/gromacs/fileio/trnio.c
src/gromacs/fileio/writeps.c
src/gromacs/fileio/xdrd.c
src/gromacs/fileio/xtcio.c
src/gromacs/gmxana/anadih.c
src/gromacs/gmxana/autocorr.c
src/gromacs/gmxana/binsearch.c
src/gromacs/gmxana/cmat.c
src/gromacs/gmxana/correl.c
src/gromacs/gmxana/dens_filter.c
src/gromacs/gmxana/dlist.c
src/gromacs/gmxana/edittop.c
src/gromacs/gmxana/eigio.c
src/gromacs/gmxana/expfit.c
src/gromacs/gmxana/fitahx.c
src/gromacs/gmxana/geminate.c
src/gromacs/gmxana/gmx_anadock.c
src/gromacs/gmxana/gmx_anaeig.c
src/gromacs/gmxana/gmx_analyze.c
src/gromacs/gmxana/gmx_angle.c
src/gromacs/gmxana/gmx_bar.c
src/gromacs/gmxana/gmx_bundle.c
src/gromacs/gmxana/gmx_chi.c
src/gromacs/gmxana/gmx_cluster.c
src/gromacs/gmxana/gmx_clustsize.c
src/gromacs/gmxana/gmx_confrms.c
src/gromacs/gmxana/gmx_current.c
src/gromacs/gmxana/gmx_density.c
src/gromacs/gmxana/gmx_densmap.c
src/gromacs/gmxana/gmx_densorder.cpp
src/gromacs/gmxana/gmx_dielectric.c
src/gromacs/gmxana/gmx_dipoles.cpp
src/gromacs/gmxana/gmx_disre.c
src/gromacs/gmxana/gmx_dos.c
src/gromacs/gmxana/gmx_dyndom.c
src/gromacs/gmxana/gmx_editconf.c
src/gromacs/gmxana/gmx_eneconv.c
src/gromacs/gmxana/gmx_enemat.c
src/gromacs/gmxana/gmx_energy.c
src/gromacs/gmxana/gmx_filter.c
src/gromacs/gmxana/gmx_genion.c
src/gromacs/gmxana/gmx_genpr.c
src/gromacs/gmxana/gmx_gyrate.c
src/gromacs/gmxana/gmx_h2order.c
src/gromacs/gmxana/gmx_helix.c
src/gromacs/gmxana/gmx_helixorient.c
src/gromacs/gmxana/gmx_hydorder.c
src/gromacs/gmxana/gmx_lie.c
src/gromacs/gmxana/gmx_make_edi.c
src/gromacs/gmxana/gmx_make_ndx.c
src/gromacs/gmxana/gmx_mdmat.c
src/gromacs/gmxana/gmx_mindist.c
src/gromacs/gmxana/gmx_mk_angndx.c
src/gromacs/gmxana/gmx_morph.c
src/gromacs/gmxana/gmx_msd.c
src/gromacs/gmxana/gmx_nmeig.c
src/gromacs/gmxana/gmx_nmens.c
src/gromacs/gmxana/gmx_nmtraj.c
src/gromacs/gmxana/gmx_options.c
src/gromacs/gmxana/gmx_order.c
src/gromacs/gmxana/gmx_polystat.c
src/gromacs/gmxana/gmx_potential.c
src/gromacs/gmxana/gmx_principal.c
src/gromacs/gmxana/gmx_rama.c
src/gromacs/gmxana/gmx_rdf.c
src/gromacs/gmxana/gmx_rms.c
src/gromacs/gmxana/gmx_rmsdist.c
src/gromacs/gmxana/gmx_rmsf.c
src/gromacs/gmxana/gmx_rotacf.c
src/gromacs/gmxana/gmx_rotmat.c
src/gromacs/gmxana/gmx_saltbr.c
src/gromacs/gmxana/gmx_saxs.c
src/gromacs/gmxana/gmx_sham.c
src/gromacs/gmxana/gmx_sigeps.c
src/gromacs/gmxana/gmx_sorient.c
src/gromacs/gmxana/gmx_spatial.c
src/gromacs/gmxana/gmx_spol.c
src/gromacs/gmxana/gmx_tcaf.c
src/gromacs/gmxana/gmx_traj.c
src/gromacs/gmxana/gmx_trjcat.c
src/gromacs/gmxana/gmx_trjorder.c
src/gromacs/gmxana/gmx_vanhove.c
src/gromacs/gmxana/gmx_velacc.c
src/gromacs/gmxana/gmx_wheel.c
src/gromacs/gmxana/gmx_xpm2ps.c
src/gromacs/gmxana/hxprops.c
src/gromacs/gmxana/levenmar.c
src/gromacs/gmxana/nrama.c
src/gromacs/gmxana/polynomials.c
src/gromacs/gmxana/powerspect.c
src/gromacs/gmxana/pp2shift.c
src/gromacs/gmxana/princ.c
src/gromacs/gmxana/sfactor.c
src/gromacs/gmxlib/calcgrid.c
src/gromacs/gmxlib/chargegroup.c
src/gromacs/gmxlib/conformation-utilities.c
src/gromacs/gmxlib/cuda_tools/copyrite_gpu.cu
src/gromacs/gmxlib/ewald_util.c
src/gromacs/gmxlib/ifunc.c
src/gromacs/gmxlib/inputrec.c
src/gromacs/gmxlib/md_logging.c
src/gromacs/gmxlib/mvdata.c
src/gromacs/gmxlib/names.c
src/gromacs/gmxlib/nonbonded/nb_free_energy.c
src/gromacs/gmxlib/nonbonded/nb_generic.c
src/gromacs/gmxlib/nonbonded/nb_generic_adress.c
src/gromacs/gmxlib/nonbonded/nb_generic_cg.c
src/gromacs/gmxlib/nonbonded/nb_kernel.c
src/gromacs/gmxlib/nonbonded/nb_kernel.h
src/gromacs/gmxlib/nrnb.c
src/gromacs/gmxlib/orires.c
src/gromacs/gmxlib/rbin.c
src/gromacs/gmxlib/readinp.c
src/gromacs/gmxlib/splitter.c
src/gromacs/gmxlib/txtdump.c
src/gromacs/gmxlib/typedefs.c
src/gromacs/gmxlib/warninp.c
src/gromacs/gmxpreprocess/add_par.c
src/gromacs/gmxpreprocess/addconf.c
src/gromacs/gmxpreprocess/calc_verletbuf.c
src/gromacs/gmxpreprocess/calch.c
src/gromacs/gmxpreprocess/compute_io.c
src/gromacs/gmxpreprocess/convparm.c
src/gromacs/gmxpreprocess/fflibutil.h
src/gromacs/gmxpreprocess/gen_ad.c
src/gromacs/gmxpreprocess/gen_maxwell_velocities.c
src/gromacs/gmxpreprocess/gen_vsite.c
src/gromacs/gmxpreprocess/genhydro.c
src/gromacs/gmxpreprocess/gmxcpp.c
src/gromacs/gmxpreprocess/gpp_atomtype.c
src/gromacs/gmxpreprocess/gpp_bond_atomtype.c
src/gromacs/gmxpreprocess/gpp_bond_atomtype.h
src/gromacs/gmxpreprocess/gpp_nextnb.c
src/gromacs/gmxpreprocess/grompp.c
src/gromacs/gmxpreprocess/h_db.c
src/gromacs/gmxpreprocess/hackblock.c
src/gromacs/gmxpreprocess/hizzie.c
src/gromacs/gmxpreprocess/insert-molecules.cpp
src/gromacs/gmxpreprocess/nm2type.c
src/gromacs/gmxpreprocess/pdb2gmx.c
src/gromacs/gmxpreprocess/pdb2top.cpp
src/gromacs/gmxpreprocess/pgutil.c
src/gromacs/gmxpreprocess/protonate.c
src/gromacs/gmxpreprocess/readir.c
src/gromacs/gmxpreprocess/readpull.c
src/gromacs/gmxpreprocess/readrot.c
src/gromacs/gmxpreprocess/resall.c
src/gromacs/gmxpreprocess/solvate.cpp
src/gromacs/gmxpreprocess/sortwater.c
src/gromacs/gmxpreprocess/specbond.c
src/gromacs/gmxpreprocess/ter_db.c
src/gromacs/gmxpreprocess/tomorse.c
src/gromacs/gmxpreprocess/tomorse.h
src/gromacs/gmxpreprocess/topdirs.c
src/gromacs/gmxpreprocess/topio.c
src/gromacs/gmxpreprocess/toppush.c
src/gromacs/gmxpreprocess/topshake.c
src/gromacs/gmxpreprocess/toputil.c
src/gromacs/gmxpreprocess/vsite_parm.c
src/gromacs/gmxpreprocess/x2top.c
src/gromacs/gmxpreprocess/xlate.c
src/gromacs/mdlib/calcmu.c
src/gromacs/mdlib/calcvir.c
src/gromacs/mdlib/clincs.c
src/gromacs/mdlib/constr.c
src/gromacs/mdlib/coupling.c
src/gromacs/mdlib/csettle.c
src/gromacs/mdlib/domdec_box.c
src/gromacs/mdlib/domdec_con.c
src/gromacs/mdlib/domdec_setup.c
src/gromacs/mdlib/domdec_top.c
src/gromacs/mdlib/ebin.c
src/gromacs/mdlib/ewald.c
src/gromacs/mdlib/expanded.c
src/gromacs/mdlib/genborn.c
src/gromacs/mdlib/genborn_allvsall.c
src/gromacs/mdlib/genborn_allvsall.h
src/gromacs/mdlib/genborn_allvsall_sse2_double.c
src/gromacs/mdlib/genborn_allvsall_sse2_double.h
src/gromacs/mdlib/genborn_allvsall_sse2_single.c
src/gromacs/mdlib/genborn_allvsall_sse2_single.h
src/gromacs/mdlib/genborn_sse2_double.c
src/gromacs/mdlib/genborn_sse2_double.h
src/gromacs/mdlib/genborn_sse2_single.c
src/gromacs/mdlib/genborn_sse2_single.h
src/gromacs/mdlib/groupcoord.c
src/gromacs/mdlib/groupcoord.h
src/gromacs/mdlib/init.c
src/gromacs/mdlib/iteratedconstraints.c
src/gromacs/mdlib/md_support.cpp
src/gromacs/mdlib/mdatom.c
src/gromacs/mdlib/mdebin.c
src/gromacs/mdlib/mdebin_bar.c
src/gromacs/mdlib/nbnxn_kernels/nbnxn_kernel_common.c
src/gromacs/mdlib/nlistheuristics.c
src/gromacs/mdlib/ns.c
src/gromacs/mdlib/nsgrid.c
src/gromacs/mdlib/perf_est.c
src/gromacs/mdlib/qm_orca.c
src/gromacs/mdlib/rf_util.c
src/gromacs/mdlib/shakef.c
src/gromacs/mdlib/shellfc.c
src/gromacs/mdlib/stat.c
src/gromacs/mdlib/tables.c
src/gromacs/mdlib/tgroup.c
src/gromacs/mdlib/tpi.c
src/gromacs/mdlib/update.c
src/gromacs/mdlib/vcm.c
src/gromacs/mdlib/vsite.c
src/gromacs/mdlib/wall.c
src/gromacs/mdlib/wnblist.c
src/gromacs/pbcutil/mshift.cpp
src/gromacs/pbcutil/pbc.c
src/gromacs/pbcutil/rmpbc.c
src/gromacs/pulling/pull.c
src/gromacs/pulling/pullutil.c
src/gromacs/simd/tests/base.cpp
src/gromacs/simd/tests/bootstrap_loadstore.cpp
src/gromacs/simd/tests/simd.cpp
src/gromacs/simd/tests/simd4.cpp
src/gromacs/simd/tests/simd4_floatingpoint.cpp
src/gromacs/simd/tests/simd4_vector_operations.cpp
src/gromacs/simd/tests/simd_floatingpoint.cpp
src/gromacs/simd/tests/simd_integer.cpp
src/gromacs/simd/tests/simd_vector_operations.cpp
src/gromacs/statistics/statistics.c
src/gromacs/statistics/statistics_test.c
src/gromacs/swap/swapcoords.c
src/gromacs/tools/check.c
src/gromacs/tools/compare.c
src/gromacs/tools/convert_tpr.c
src/gromacs/topology/atomprop.cpp
src/gromacs/topology/index.cpp
src/gromacs/topology/mtop_util.c
src/gromacs/topology/symtab.cpp
src/gromacs/topology/topsort.c
src/gromacs/trajectoryanalysis/cmdlinerunner.cpp
src/gromacs/trajectoryanalysis/modules/nsc.c
src/gromacs/trajectoryanalysis/runnercommon.cpp
src/programs/mdrun/membed.c
src/programs/view/buttons.cpp
src/programs/view/fgrid.cpp
src/programs/view/filter.cpp
src/programs/view/logo.cpp
src/programs/view/molps.cpp
src/programs/view/nleg.cpp
src/programs/view/nmol.cpp
src/programs/view/popup.cpp
src/programs/view/pulldown.cpp
src/programs/view/x11.cpp
src/programs/view/xdlg.cpp
src/programs/view/xdlghi.cpp
src/programs/view/xdlgitem.cpp
src/programs/view/xmb.cpp
src/programs/view/xutil.cpp

index 7b0f9ba2399765744378878f5f6b7e9a3daba218..d0184d1a8302927112416ac263f93a298110eb2a 100644 (file)
  * To help us fund GROMACS development, we humbly ask that you cite
  * the research papers on the package. Check out http://www.gromacs.org.
  */
-/* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
 #include "gromacs/commandline/pargs.h"
 
-#include "config.h"
-
 #include <cstdlib>
 #include <cstring>
 
index 38c26175932fc4abe41f0b8120a07076a01016a6..38be02d5236b9e5780088ebd2e8f17b16d074410 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <string.h>
 #include <time.h>
index 4703911cc6c3bc8b5a97cfaa6ab657ce727d2cfe..c0f412bf6ebd8f688cbdeabe6b2c1b3c8beb6fc9 100644 (file)
@@ -37,8 +37,6 @@
 
 #include "gromacs/fft/fft.h"
 
-#include "config.h"
-
 #include <errno.h>
 #include <math.h>
 #include <stdlib.h>
index 1cf35884caa73f5f4ce0f312c283e919c94ef02f..fc9694e5eb91d08612e8d87034d791f29c2d1e34 100644 (file)
@@ -35,8 +35,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <errno.h>
 #include <stdlib.h>
 
index b1917bd4c28d3ce17fe4b293d936bfcd952698cc..ff69a13bc850d08e03a1b13baf4411a9b27834bb 100644 (file)
@@ -35,8 +35,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 #include <errno.h>
index 841317695eff1ec6b2d51c7a27f01014d7983c6e..36dbc53312fd781d3f42ea2301189272c2ee4a3d 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "confio.h"
 
-#include "config.h"
-
 #include <errno.h>
 #include <math.h>
 #include <stdio.h>
index 9c01b1ccadc238cf3b0a0c228fc945cd0b12f496..d6dce5f4ab98e589d84a9c33cf08f3a2d5f0cf36 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "enxio.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index d132e44d66ee051d95642120a73faae6666d5a9b..d8b50e526f3dc98de1ec1ecae7fcade293320616 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "filenm.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <string.h>
 
index e93bded448784a2c017afc2e3f57f733f46e7e84..98957275c014e2dd401ed5f8a54168f262951832 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <limits.h>
 #include <math.h>
 #include <stdio.h>
index c7d1dbb1e1d7e497482a1da1ebba6c982626e4a6..6d464f8c91b1b8574ad8d64da302cfd3b839181b 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "matio.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <stdio.h>
 
index 99120369eb9064840535f67f7caf258a954c983f..f2a27e0eaffec0c879a850eea83ad97d229299be 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "mtxio.h"
 
-#include "config.h"
-
 /* This module provides routines to read/write sparse or full storage
  * matrices from/to files. It is normally used for the Hessian matrix
  * in normal mode analysis.
index 5ca147c23084de46a669811c007f080b0a0337d6..05c0cf13222ce646afd0e0049ea179cb8c795764 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "pdbio.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <stdlib.h>
 #include <string.h>
index 47b04b99a97a76735219a05e8c0ffbcb693ed24c..21f70b014f3f0f8a65529eeeb8789cc151e8410d 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "strdb.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdlib.h>
 #include <string.h>
index c4c3cbbe4b32ffe52ae40b198ef25f38ccd390a3..4c355ae13b71d6217f4cc1aac446d1ac7ad760d6 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "gromacs/fileio/timecontrol.h"
 
-#include "config.h"
-
 #include "thread_mpi/threads.h"
 
 #include "gromacs/utility/basedefinitions.h"
index 9dd4f30ec239337a8d4b89a3cea9290e38025d3f..5d0c85380a64e08789f0a108d0dacf927f3f49a1 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 /* This file is completely threadsafe - keep it that way! */
 
 #include <stdlib.h>
index 2780a76ad853599c485c694e7480b3485c8a3be9..c28a834bb52c0f7d0624723e334437ba99084d11 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/utility/smalloc.h"
 #include "gromacs/math/vec.h"
index a01cd2da6b0f959cbab05baa3da17ac0b682338f..a85a82f3c98cefc6f326370f77b3569b4b10af4a 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 #include "gromacs/utility/smalloc.h"
 #include "gromacs/utility/fatalerror.h"
index 953bf4e24b67d72048433ea53b4250763d635084..cd9d1b407fb5e17ceb77d94dc54b3848642d05b2 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "writeps.h"
 
-#include "config.h"
-
 #include <stdio.h>
 
 #include "gromacs/utility/fatalerror.h"
index 794c46ca2f9db821ffe0d2f9b5e82cb2d1c7af1d..7edfe5911a1a17ceddb26af239d88d8610a3adc8 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "xdrf.h"
 
-#include "config.h"
-
 #include "gromacs/math/vectypes.h"
 #include "gromacs/utility/fatalerror.h"
 #include "gromacs/utility/smalloc.h"
index a6b39b48007c9a0fd9b6f8cf094cf45ca4497adf..248146417a3c9b66342d7cf088c48563922c8f4c 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "xtcio.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include "gromacs/fileio/gmxfio.h"
index e3daa2b2896fd7fc0fc7a15f56bac6523d47cd0f..a73525d6768b5d8025a11513c3990b435f8bda71 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <string.h>
index 3b52f0d30562eb560fc778e68a5a3e8c3dec6eb3..5e829a986d6d8884cf267c5869847dcbd80dd91d 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <string.h>
index 4228e35faae4244bfaf99a8ac6966694586b579a..ac5135bef4fcc177a2f530245cab9f29df03083b 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 
 #include "gromacs/utility/fatalerror.h"
index 1015377ed8c2007cc772eaa580e7fd45739c0934..fab169f798f615da7d29813a213db408372b9570 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "cmat.h"
 #include "gromacs/utility/smalloc.h"
 #include "gromacs/legacyheaders/macros.h"
index 6860f3a1e5ba4f2f14801c38b6edfa06f874aebc..b223ad0adb1b5339a387436880b009f15aac2054 100644 (file)
@@ -37,8 +37,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdlib.h>
 #include <math.h>
index c594218956a9a6c506af4d36df26eaf04c7716ea..0bf0bfc7d2959bfca99098b5dba2afd0d65bcef8 100644 (file)
@@ -35,7 +35,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
 /* dens_filter.c
  * Routines for Filters and convolutions
  */
index 0940e62715c69aed47e2378e70f1085668a23aef..d1e1d27a3bb6f223d128af72186e8907446c9696 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index cefa9692b740d41c73ac9ec8cc440102aa342065..9902937cedfca0a03d71dfd6d99c30f6a480decd 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/topology/symtab.h"
 #include "gromacs/utility/smalloc.h"
index d426a0a5c1bfc25be63036c58dc06e93e2bec681..b645b777ca43a4df37168e82d6ec6e28433b70cd 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/utility/smalloc.h"
 #include "gromacs/math/vec.h"
 #include "eigio.h"
index 116c7e37935c9e0303232727594b4bdbb615feb0..b9d57723a104139b486943997ef3f96a97b82dbc 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 16700170b2a4e8e0189bd3ecd26532e141a212f1..02816002294db37caff1d30480663fabb9487528 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "fitahx.h"
 #include "gromacs/math/vec.h"
 
index 19699c0b34cb0e205386246f4d71ddd2c4863966..273f7ae92ab03f29d17af30bc6f2f9f98e11cec6 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 
index a81a80a8f039ffb0d528aafb80b7fc244d7ec3de..b0e506085cb71da42227998db5cbadbabd0eb13f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index 937d857f1872d06ce573aacbbfab77cce5c24a4a..dde9815f2a3322cfbfca087f19ba341c43d3a121 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 08ecac0d83c7f8d564c7b3d9c15fa38bcdc48ad1..94400867e5f00bfd2efafa911010a57991817292 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 83abe0aab7c93073385abaddf6ddfe5cbb1d4699..8064d062f104d40ff76e41e7f1cd8befd8bec31b 100644 (file)
@@ -36,7 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
 #include <math.h>
 #include <string.h>
 
index 496d379b82af48562ed59dc8691d171fb26bb92e..e366081d07f85b3931b0c2c5946df218068e6ff9 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <float.h>
 #include <math.h>
index 9cb602d93a71dd7f5a1659b362c29dce9bc4526f..d98f7d600ee969c141171257ab93e201c95812c2 100644 (file)
@@ -36,7 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
 #include <math.h>
 #include <string.h>
 
index 3ee3ceabe03e9e8366ed5d771ff0a43aa70ebd3a..0c5a02a21c618429bd73bbd6a394f99e02fa3ac4 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <string.h>
index 1b099c411cc87cfedac04d49662fa1b8e408a820..4632a5900a16af9f55df30f1ec785ccb4d42c584 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 538d21a1d4368fc3e56223573362449a03d86930..3800dceca998cc86a3c53348e66e8387ca0a33d0 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index 9d4e9407786e1756d2c4686603a16bec6fa08bda..c0876922bb6b95515d97297d485497ede9c1e284 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 1697d39bb0eb7af67ad09dce195138cdc89762dd..1f41368c1af5e7e0671eb067184f1c4cd7d653c1 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <stdlib.h>
 
index 5ebf4b74dc60d00cc5dae044792a6e2172b7b1c6..4282430de0c8bd12af67f574d197d3dcc98f8464 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <math.h>
 #include <stdlib.h>
index eec8ef00532c9b8f5476de079f805c1a9b4ff389..a71c04137f4f622bf3b3852232f5fefeb390ffa0 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 79db631c1ee2e8b3c376711eba7752c094fe97f0..79c9e68a11d717f66303fca84f06d02f018fd4d7 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <math.h>
 #include <string.h>
index db2607a2ef0bcbfdd0ce5ede3a4beddc5342d0e8..e9c6445dd6a2f20a281d527f0be540bcf99f0a1b 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <stdlib.h>
index 2382a42d427a303aab31daba1ad5928c7f68a232..569954d341f676fd0911662054a20ba1a7fe34a9 100644 (file)
@@ -36,7 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
 #include <string.h>
 #include <math.h>
 
index 5bf8dfa13f178dc1591f3fb140581976a2b1f085..4852d3616ba03fcde44ebb91a254eba76594768f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 99deca2849309c5881a4710e966ba23873dbc2d1..e353d7a3e87c0b475ceceea777ebc2494ffb9f22 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <stdlib.h>
index 8a82998ab37bfd653e1bec94a34c2ca472b1501e..7b2ac8e4993c2884e3ffdba910bdd161c5451ae1 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/topology/index.h"
 #include "gromacs/fileio/confio.h"
 #include "gromacs/math/units.h"
index a17427cff3506bc7c013e394d791b729880174fc..c710ecfd1587ab6adbfd6d034f291453e88f00e0 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 9dd61c8d94e78f31d47bd9b6439a248e4c1264d0..34dea5935738d8c995594dca0461d92d62e6f397 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 4633ca3fe340a9a0a45e84a21d90fc6506fe4fb6..8abd1f3abca42a9e0cbb575ef058381e18908e14 100644 (file)
@@ -36,7 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
 #include <string.h>
 #include <math.h>
 
index c5c8447dc7ce2f13afe65277da1593337158a1a7..cc3958fda13017f1e1d6090a92f0e8c55eba1c05 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index a16c630b6df276b256c51e56135520a6738a836c..4b1909c8a3c28d31e3e3e49eb62f5ffaef164173 100644 (file)
@@ -36,7 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
 #include <math.h>
 #include <string.h>
 
index 494514571deb3f77c440a157fc467bc34dccae3f..fc1ac0e8e8be57d0cb44caa1d8144d1ae10fb557 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <stdlib.h>
 #include <string.h>
index c0a983c441380bc57d36e6369f7cba9e203dd8dc..a883f697a8c96dd993235a9ba07fba555e48b465 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 4408617022e549af711a049982fb10d3b9ec907e..f8bb1f3758a1634ed0d747d318b579929ea4ace7 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index ca338f90151ff0fd02c621b997afda93adf7ee79..314f20c46a91a28bec246b4848ce402840b025ee 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index b6af91893c313ad3ce5b6daba67e6d3df068092d..70c24752fba4ca3c12e7796e5d86d38aefffd532 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index c8504946efa80b045b8165c7acdd45418aeb99ce..b42a518b1da805b242efa3a7ecc85bfef06a47e9 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index 284a99bc3158e4b9f1ca5625d57ff97fe1b20aa6..af7ecb739ee0a1f52d3522f34dd914433122860b 100644 (file)
@@ -35,8 +35,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 290f3d2b8497f72e6e6013cc4b3e27d9b5a74cc3..250256d475dd523b7dd75ed653d9d17582991e9f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <stdlib.h>
index 1825f5803c5320a8ac831b52bd55d3bf6a9741d7..7c1ec8411c9443f5838ec253b7836984c13d02d6 100644 (file)
@@ -38,8 +38,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <ctype.h>
index 3415ff59db0290ed5eb35527c3b6e21c18d6afc2..be16251aefdbd1ded43fa13387901390e7025564 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <string.h>
 
index 6b24575bcae4ddb88977aed89ea8bb03368a82bc..cc0a6e2becd0df019bb5834520598008f9b4516e 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index adc023494e72650df46b567568d78450e0e8ea72..3b732ffe0a8e549191962b0f7d3598f2724a4f79 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 6cc12dcc5be5d5c33dc686dac34cc45ff6325b91..1b1ceeead65bb25587bf68635b3e20fa7e87b10c 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/utility/smalloc.h"
index a4bf81f835bc9b61d746487e35c1b35b2030456d..8e77699e8935121e8ee27e6bc965fa690644dc9b 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/macros.h"
 #include "gromacs/fileio/confio.h"
 #include "gromacs/legacyheaders/viewit.h"
index e5fb4cd24eb44565cc36d3c9891f99fadbeff9f9..701f412114e164f4963288aee2fa1c41b8205439 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index f27e781c8b4b315461ca51bf1e5f7741bdeaa5e3..63fb24daa3ae8ce676c06f4804c5253e5f518517 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 949ca6c48de57bc1ce42bcab762b159417c672ba..a734478f8df100652ac3eda5e6be5a89db44b4f4 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 5633baebef5bf2160a10be0614ccb674d35eacc9..661caf2749d696f9419980273f7ac10c27c5d3fd 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 874d4082d013155852c339d07cdb8d0819c7a9df..4a98b8348a07ddb6feef3b32a74b49888773bfd1 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/macros.h"
 #include "gromacs/commandline/pargs.h"
index 5decb2224fcbf1832bd93568d04987a8304861d3..0c6e723316b6730e4c603b296c2de4e5e8f00bb5 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 5cccbf94631feb89bc35d5835df508ca0426aca5..b98fdaf12aa890bfa9e4d7de20f5fe369a2362aa 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 989eadad9549002f3f44bda576c7e445ed29925c..54ddc2ac8a87607c80fb415704a392891928fd7f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <math.h>
 #include <string.h>
index b4828409b5af045c1ebbab6aa9ce18bee9413405..5be044744ab095602cdf27bac3fd8dff8ccffa50 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 037517f15885d78515f990f5357694bcc502f44f..f5db3dfada26f097ec0913d69e94354fc00d4810 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index ca54a4def4946371e9cf223299d42e877a97cd87..db06a912796122df176f76a9a0a3f4834034b603 100644 (file)
@@ -37,8 +37,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index 468cc3f377d5b6bc5c926bc55b89b60a4844a454..24af686324c5c1ba96a3c2dc424c946abf0dc117 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 
index b7fdfca625ec70fd2f453847deecbf62bb25549f..504ba2abc285f8e307414267199abeb111665d8e 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/macros.h"
index 535feb5c7bcc76ac5cb4685762363f409f1ee810..de56950586c5fc53507decd4665a0b9dc9ba1958 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/utility/smalloc.h"
index 073d131e518e4c1b721235f9fd14f70edb0cc6ed..18f4f33a9da629f33fdda01477d8d51e24d3dd45 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 54f012416dcf6a102f5a0d4f0cc919a2e1d8c862..e4606039b4fc5433773f42297e8d0f825f9c4447 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 440769985d8e139264a18b93472f9c444c903f6c..23381e2db7486788b0280b27f19b22085d2378f3 100644 (file)
@@ -36,7 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
 #include <math.h>
 #include <string.h>
 
index 9b23bde9849c4d7983c89571aadff47cf76e6163..73ab9694db1cbaa36eb65588c06d8c9231e62e2f 100644 (file)
@@ -37,8 +37,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/macros.h"
index 85837ed10834f37fa3ebb6340b969622bc60bda1..c2a0ae7423f9e7e75b8fa638c60fd83e1172edb6 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 559e16c23343dc683992aecde61afd7fff92350e..a4860c8d70e6a1266ae506ffb6a77802a21279f5 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 
index 5c963b771a890155a42c600981429847862cf67f..5a66da9cfaf1988e68fbc1395f22b551c4d38c97 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/macros.h"
 #include "gstat.h"
 #include "gromacs/math/vec.h"
index 01fccfc1d9a415558534d6a417a77a04df60a9c1..4eb86003d4e6c0b8ba8dc112c019fbbae7b65028 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 
index c9b160be13e771a9d359984e88477907f89c3276..9642214a431afe5adfd3ef175f9c4b9dc071a401 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/macros.h"
 #include "gstat.h"
 #include "gromacs/legacyheaders/viewit.h"
index 9c66c0a7811b5a612d917240012ff5a972daf1fc..cf72122974457feb48e2ae1505d0eaa0555b26b6 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <string.h>
index 6b1297e122cdb1019e6c5438cac04eb689441223..2c208073554cd5e4bb70de2c0d96edf32edf0078 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index fcfce74a3ecff24d46eaaf336482e3800d75f45f..5a011c992ccd64feb2f85ce8fd296b72ce1abaee 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 0a13b114104dc9c97ff405de91c51fce20f519bc..bdf5cb3569232023f399224bf44cb621021cdb7c 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index bef1db6432e5282fd6e2738254b5a3208ffcdaef..781fc5cf1f37f22d329395c82682f2799f4bec41 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <math.h>
 #include <stdlib.h>
index 0130410ab20b48091c5fdd3f993fdfb8d93f8d57..b6567a4813defbafb2bf39c5bfa1abbac644e874 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <string.h>
index 73d9de4759c2533b72a03cedac4c0dcd6d28b968..d990df1180674e64d9a8703ce6816c693ec79760 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <stdlib.h>
index 779313cc7005e9a635d4781da34aed83df0f662e..0e2bd1f6767a3576d94682fa2ffd2a7007564017 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdlib.h>
 #include <math.h>
index c47fca8dbf1f6701d6163792a5c2c35f61638c9e..bad612044ae8d1f41bf1e256b75b72bcccee1e54 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 99e06dabe3c08713287d7cefd31d68ae15256afd..c84f103bc0e221158c0c2bca5f88fc38d448f06e 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <stdlib.h>
index edd6d73137e2597bb7d38bac39c6ec4a14f5f489..a69fc8a3bd837111065f7547aaea6879c7072420 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 
index e0be0a32f931f46c19aec528e5e4d4bc8adac84a..91cd15ff8925f0b78ddee4b95bc0ef7090281c04 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <math.h>
 #include "gromacs/legacyheaders/typedefs.h"
index 91936a56b26b3c3fc18dbc8e465dc2e8538e4740..071e50afaddd7daf1732a021362465720fdde496 100644 (file)
@@ -35,8 +35,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/utility/smalloc.h"
 #include "gromacs/fft/fft.h"
 #include "gromacs/utility/fatalerror.h"
index 9ad592fb62f4cdb96e77ed90447e7d584d37899a..4c7fdb951d647a07c14a0426c4075f93ed4a4db2 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <math.h>
 #include "gromacs/legacyheaders/typedefs.h"
index b202935ecba0c56ce0bb171fc260144c8d94c54d..e3906590a4febe3986c34ac74a74b3eb7b458462 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/utility/smalloc.h"
index ff62732e7a976085526f3bbaf60534568c4d4f82..8d027fe4a52cbe945223c5fd103a3618f5044308 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/utility/smalloc.h"
 #include "gromacs/utility/futil.h"
 #include "gromacs/math/utilities.h"
index 9e1f1704d340cb544346fa437ebfaa62dbdf606d..62d25e1ce88839af9cf52dfcad8f95565d21ba8d 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index f291d1f3af00ef292b7366e41f3017d866d96ed3..00dbf09dcfa342420d3774b9cf9f392f1a39269f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/math/vec.h"
index 5b78f1b89b070a14f47a1eb77b288a7597a88b1c..59f433fa5d8a5b269cbac0e7e4bda9caad34fde5 100644 (file)
@@ -39,8 +39,6 @@
 
 #include "conformation-utilities.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/legacyheaders/macros.h"
 #include "gromacs/math/vec.h"
index 364c1597c7af63024ba8a8f3089a4ab421569416..76f92224126a517cfd7d2b58ecff725765d0f2fb 100644 (file)
@@ -35,8 +35,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <cuda.h>
 #include <cuda_runtime_api.h>
index 56215773bcd2f2b03dde7d4a57f0ff131e7603a2..44dc2271f36d33af2151cf657a655ab9a10a98ef 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <math.h>
 #include "gromacs/math/utilities.h"
index 342058cb5aa91a73a0ed62f82555988d72ec6c3a..e27b78aa22c23e51d52228a0b2e185a039bed094 100644 (file)
@@ -37,9 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
-
 #include "gromacs/bonded/bonded.h"
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/disre.h"
index 43283e1025d2468ed213e1fe6303b22842278807..d55f8e4ed57b6d045db20f9052a9dfd18f9e4bb0 100644 (file)
@@ -36,9 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/macros.h"
 #include "gromacs/legacyheaders/inputrec.h"
index 5dc7866d4e2e856045740da3714941e0d4c89384..36eb06d964799359be249274f296eea082b798b3 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdarg.h>
 #include "gromacs/legacyheaders/types/commrec.h"
index 9db70030d29f742ca5a50c15269a9ba18bbf6c28..8885b13c0e267613c2ec46010b72a397c2bf829d 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index a72b2a1d74f60b4841b9de787a1232a985dcbed6..0e048d42db8325c0dd8d7a7f6309ab16ff21c2a3 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/names.h"
 
index fc6ca9bc67dad6cccce09f9ac0bbd7da00f6cb7c..35175bc2173467d481facccb09de6ad684eb74b2 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/math/vec.h"
index 54a7d3af7137cb9b41cb565b44e22faa071765a4..dca18ad4fa08645054239d97e89921af7f1b31fc 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/types/simple.h"
index 5c4d0013bbd47699313933d0dc512512dfbcd73c..eedffd8645d45a89748f9c0eed79f137e2f80ade 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/types/simple.h"
index 85c32b473eda4bc5bad8487613071b5307458832..97c43c2b0b9b86df012bcae8a0841508badb6b6a 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/types/simple.h"
index 158dc5eef82d694dc9ad5b4f44a00ac6d57af85a..60f73652a2a7ab1283ae918756e3268bed7570d7 100644 (file)
@@ -34,9 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
-
 #include <stdio.h>
 #include <string.h>
 
index 9f28c063b506fe99da0bae7262210ee04d08a9b7..c5d489949abd4cdb05007a205bdeb1dc38f32ab6 100644 (file)
@@ -35,9 +35,6 @@
 #ifndef _nb_kernel_h_
 #define _nb_kernel_h_
 
-#include "config.h"
-
-
 #ifdef __cplusplus
 extern "C" {
 #endif
index bd3078ee11f339006c626fce35f0f64644a0a0eb..54925d85ed4d95591c22e3dbd0b0ea8053048d8d 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index 52ca63071c1b72ab7f698ef434710b5e72549d52..3c4f3e5db53d54e5e66277d9d0e6c8023a020f96 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/types/commrec.h"
 #include "gromacs/legacyheaders/network.h"
index 5d71c14628650d149ea2315aa8a9a4d5c85a3da4..5ef4d5d229aabe7de030cf7cbe227ea7ef4aeb66 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/network.h"
 #include "gromacs/legacyheaders/rbin.h"
index ff55b9dc7b26d315d682dc1ffa4dea1117e3ba86..0f2e4196d7dead9aae3527463905c1f420920a96 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdlib.h>
 #include "gromacs/legacyheaders/typedefs.h"
index 98ab01916ff330380c812b49ed1a2d988b074a71..b9557b54a74231e2f12832604bade7e517be4d30 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "gromacs/legacyheaders/splitter.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <stdlib.h>
 #include <string.h>
index dbda154892e3c18665dc1b34bc4df8a1223ecc91..b8d3088c736a04d647dd62c7918709c6866d9b95 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 /* This file is completely threadsafe - please keep it that way! */
 
 #include <stdio.h>
index a1508fc9b8609990afc499a0a4270043fac14001..134f8c0ca55a3d1e4829d4f7c7550360d5e762f5 100644 (file)
@@ -39,8 +39,6 @@
 
 #include "gromacs/legacyheaders/typedefs.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include "gromacs/legacyheaders/macros.h"
index bdf882dafd21ae44dfca28df5ecd03ea16ab70d4..9d9b5b79b69b516fadf5d764af58f68da4ab48c4 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include "gromacs/utility/smalloc.h"
index 15971725d186d8903bfaf70ded8a3050d854ab80..26926a91d4f8213febc266f19adac64c57e4a229 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/utility/smalloc.h"
index 57928b5f6489b189217d08de0b4688b18fe2fc2f..b2d1f3a751324474be505a5c681500f35102505b 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "addconf.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index 29cd01d86a3cb40c139746c3f6899c079d4023dc..8d1313a4083a8fc3d976f91dfab58e06cfdee47c 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <math.h>
 #include <stdlib.h>
index 4eff9edc426655ed4eb34d524c1222b07da94137..dfab85b064e1e74aceb6e736e389b3e4f541c1a7 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/macros.h"
 #include "calch.h"
 #include "gromacs/math/utilities.h"
index a9ff5768a29c1d232787e8dd822098573f907433..8de74782b7055b5dfff81fc554628761e430c36d 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <signal.h>
 #include <stdlib.h>
 #include "gromacs/legacyheaders/typedefs.h"
index 8369a030c5f9c852fe9c9fee9c0b8f9a64de3373..3ae40c2a840f04633487f665dbe40ae60a0c0e71 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index ca09f47a8033e7e72f5f7ddc56cc270ae2d67939..f49d96327b075c078011a17bd73a5980b73723da 100644 (file)
@@ -36,8 +36,6 @@
 #ifndef GMX_GMXPREPROCESS_FFLIBUTIL_H
 #define GMX_GMXPREPROCESS_FFLIBUTIL_H
 
-#include "config.h"
-
 #include <stdio.h>
 #include "gromacs/legacyheaders/typedefs.h"
 
index b5c55421c1f9b5c8e54881473daafc1b73e4d756..c110bc7a3e4a31963416a849307e1a9256152a08 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <math.h>
 #include <stdlib.h>
index ee0d106f6429e2c6a00d02c9669f45188c420cea..609650f4a13aa21e4811bcefdc5d08be81681027 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/random/random.h"
 #include "gromacs/utility/smalloc.h"
index 30dace6b29181a92c56699d0d287499ac112d8e1..9743f690a6d7a7a271d2df1c703aa92a2f0154ea 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <stdlib.h>
index 50be75ef5492b067baff080d09ea09f4177a71a1..9ac5b4d4448c573ab1f8032520d6f85c0eb5aa1c 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 #include <time.h>
 
index edfb7d8249e51bc2ef6ee9cbf963363837ed4356..81795e98054c763b97a2eb8eda83a77ca965ef52 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <sys/types.h>
 #include <stdio.h>
 #include <stdlib.h>
index 3a12a4dd82c4c055f0d72a95ba88fd8f75cf3681..8ef380fd04d7ab65191ceabaec731488abb409a5 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index a8e949e3dab73e0bece44a739ea0c1407a9aae43..905308b3be91ff1d1d2beb3f97226e049964d18d 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/macros.h"
 #include "gpp_bond_atomtype.h"
 
index 592ed8f575b9ed09ec3f5a4fcdfe0184763eb966..cd88c07a81d8e584dda44e6090f4a64334d665a2 100644 (file)
@@ -38,8 +38,6 @@
 #ifndef GMX_GMXPREPROCESS_GPP_BONDATOMTYPE_H
 #define GMX_GMXPREPROCESS_GPP_BONDATOMTYPE_H
 
-#include "config.h"
-
 #include <stdio.h>
 #include "gromacs/legacyheaders/typedefs.h"
 
index a5002347d0b0ce11f784f9ae18a39ab431cbe239..ff7bbaff4e0dfca3ee41b657e798926c923aba4c 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 
 /* #define DEBUG_NNB */
index 0f47a5a61296e28561f1f4b2830770fd9c2e6c7f..d8cde70d4e26046e4926941803f633eec6f92d59 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "grompp.h"
 
-#include "config.h"
-
 #include <sys/types.h>
 #include <math.h>
 #include <string.h>
index 398a53689e421b3d727368a41ed108ac53010d49..85bacf8a3f95274892bf20cf8657dd963ad36ff4 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index e80b140b3826e0c4459159321fb14e0e18c0ba75..ff7f0fdf2e742c565c4b0043d7351afefc8f5741 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 #include "hackblock.h"
 #include "gromacs/utility/cstringutil.h"
index 936a434feeb208f24561bb6d62bd826961b84aa5..e7b637a21be99924791c2453333add47953a2614 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <string.h>
 #include "gromacs/legacyheaders/typedefs.h"
index f1fd79b70432ff35fcd07593185cbab759a4347e..32d5908987e4e7eb53000cf4f087f79f9eb9cdc0 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "insert-molecules.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/math/utilities.h"
 #include "gromacs/fileio/confio.h"
index e7fe17388d9d7b26bc31aaa6d1578df580610280..d4b01a884dfae8a5dcdd3b11eda4fff0d509dccb 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include "gromacs/math/utilities.h"
index ec26e5f22ca4638c09dc6c1b1ae7a98c606b1aa6..0a1aeb20d41ecd14255f0854778d09539509f2e7 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "pdb2gmx.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <stdlib.h>
 #include <string.h>
index 9dfbfdffbbc3cc3986f4d557074566b0f6b70e5a..ec4f8927ce5d570c14cde224c8b774b9cb3e429c 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <math.h>
 #include <ctype.h>
index 811360c52219f6c48b88ca0083a77423b7319e08..1cebc523b6ec3661774f6e5c9b808960cc14e610 100644 (file)
@@ -38,7 +38,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
 #include "gromacs/utility/cstringutil.h"
 #include "pgutil.h"
 #include <string.h>
index 86c87d68267a2d372cba8f4692c3f29a94dfdff3..5f1d99f6fce8a97de85e82d2696333337f8fbe78 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "protonate.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/utility/cstringutil.h"
 #include "gromacs/legacyheaders/typedefs.h"
index 7fcd21cd9f92c25ea1cd5faafe938c1793414ccd..b12714eb7882944edea49bf1147aa936431f0430 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <limits.h>
 #include <stdlib.h>
index 687ae35ef38ddf1269d912178837badaacec2846..70e484aae63279fb7f477931370eb21cab1119de 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 #include <stdlib.h>
 
index 3ed1bdb01ee66e83cd41b4ccc8f8f2aa0157b984..527aca8764653c0c1207ccc035612c056910e5ba 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/math/vec.h"
 #include "gromacs/utility/smalloc.h"
 #include "readir.h"
index a80bcd6231c527064e05c87ca1a6782e8dca8cc9..b363023b1d31f0b8e768240af1ea9ccf9b6d1917 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <stdlib.h>
 #include <string.h>
index 46fd66c06dc188596c42cc92f29b371b472ba0f8..421a49a2073b04eade2e6fcd29c9cec934580688 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "solvate.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index aea7ac8d3e5c22c4a2352d9b24dd430918170018..43dcda6c5d29e03ce58bf5947f39c100efd2bc9f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index 60baa774055ceace028fbc1a5ccae4b97b696414..208092882bc52b4888eb45e53651cbab7ecca0c4 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <math.h>
 #include <string.h>
index e55ec6d115109dcf30231b4e7b7f65f79b6aadc9..4817b27942da8165a770e76577f416629d8c0a46 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <string.h>
 
index 16110bdbca07921a4031cda861f364649920515f..a326f16f0a874239fbc2484d5436abcc9ae24dfa 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <math.h>
 #include <stdlib.h>
index fb661030334c30eece222eacc30cf41ea5303260..e24817c8297e8cbc272cd7756b7dd91810751216 100644 (file)
@@ -38,8 +38,6 @@
 #ifndef GMX_GMXPREPROCESS_TOMORSE_H
 #define GMX_GMXPREPROCESS_TOMORSE_H
 
-#include "config.h"
-
 #include <stdio.h>
 #include "gromacs/legacyheaders/typedefs.h"
 
index 9435cb36e08d6dc225e7e0f7d8cd9aa4fd50574f..d46b6922a8ab678408183c0b890ce95644f5a271 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdarg.h>
 
index e96195737b9d49671ea4f96726ba3cf691ed2d2d..f7efad094cf21ac20e3ccba791e7af356f8f2f81 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <ctype.h>
 #include <errno.h>
index 53616ab2a63dd3cfa26a60abdddbf1f5b5c9aec4..fdefac9f1401f70fa0288375cd09bcc159bd2125 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <ctype.h>
 #include <math.h>
index 342863854242244c3792786e2d80dba4b2e58b4d..66a1036bdcfe32a71b33a8ffc0df7840fb9fec43 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <math.h>
 
index 9c4da0eb1b8c945e31eb46a52975b60135b32aa9..a407b711df95ab1376f662570ddb3a267f630a26 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <math.h>
 #include <string.h>
index 0671ee4027ce4f03866567b8696279ea80c36775..edeab6fe4bb4521ff8ea71c3d2eb4b75260f9012 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <math.h>
 #include <stdio.h>
index 4157453f26fde6d5542424260cb273c400d3e9d6..f0ae9ad8d8bdcaddfa266c2615d3b98fca20c598 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "x2top.h"
 
-#include "config.h"
-
 #include <assert.h>
 
 #include "gromacs/legacyheaders/copyrite.h"
index 5cbf20e8ed25729da644c3b91f6a4e6c4900f3b3..d8dfc594f89a3b7352a6f78c401658a056dce705 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <string.h>
 
index 34a95d1dc1b77f97226a5a2e118b4604738a8a9b..618b9cf0a26e4114117134aa39930e4e4e06fb62 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdlib.h>
 
index 61345f9fbe294c9bc1848ab4b2df7889365eb1ee..19d27411a11e0b6acc5d9c9fd7bf130e1c5a4f13 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/force.h"
 #include "gromacs/legacyheaders/macros.h"
 
index 6bb939a41f3ff1651549ecbad535e7ab2e8e95a3..2b45442554d1b2a51e4cbfd0c84726bfe0059ada 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 
index ca4c898e6827d60791af7f8eece2afb551ddaf28..7b9addc389e06f2ba2280bef92059f0a2e17fee2 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <stdlib.h>
 
index 2519f11141e54f22ad7a1beb9ae6a8397f628308..7583da13815a4d61edabc6a83c2da295969e404a 100644 (file)
@@ -36,7 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
 #include <assert.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index fe270bff09c1f962c03821637515069d85c1b60f..44920009a9adeed85934b49ee2de1f90e221af2c 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 
index 5a30255b7d3ea3a96da74f3d9e2b0d659220a487..89fc97c82084bbc2411792f3c92cf9cfda3d2d17 100644 (file)
@@ -35,8 +35,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/pbcutil/pbc.h"
index ba6baf6fbc0358a02aced0cf69c18d6494c84a3b..e83c16930ef29fae671a8d06f30309959cfb0e56 100644 (file)
@@ -35,7 +35,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
 #include <assert.h>
 
 #include "gromacs/math/vec.h"
index a8c4443f2ca0021316319b12b84711b8fb625b1d..5caa68a9b58508750b040a2e4140d07cb00c1d48 100644 (file)
@@ -35,8 +35,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <assert.h>
 #include "gromacs/legacyheaders/domdec.h"
index 2e752241d5af0fb712cdd4f33092dbb733b40917..8360e45540e56cac3cea945970dfe39d4d3504ac 100644 (file)
@@ -35,8 +35,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index 8dbebee9de718ddf55992e3a876b7a7c79684046..33a0742130c8aaf96893ad22a087d43c134bf7f9 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 #include "gromacs/utility/smalloc.h"
index e4b789df76f2e235f3741b21add66d24cd93d299..bcf1865df33e118fe24bc5d3f14785ac031912ca 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <stdlib.h>
index 0da29661003cf0cbacb761072d20c7e2848a9da3..be1ea75c670a83719bfb7c59ccfcb400ab289513 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 
index 23caa377f5d67e843479c736bc116fa20ca31adf..f3a8973262879fa4a565647b6a3b699a62402625 100644 (file)
@@ -37,8 +37,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index fe9d4c8e6c9686e5ab5efca2090b5ce249e5a9b5..b294cbbf5ebd4b6d116a211a403f34d1b91ed3c0 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/legacyheaders/types/simple.h"
 
index 9ef56e08abf4a4bab4b7ccfc7de52be8d52b9694..1f91757d1638085eda9130c2ed4d9796b548968d 100644 (file)
@@ -37,8 +37,6 @@
 #ifndef _GENBORN_ALLVSALL_H
 #define _GENBORN_ALLVSALL_H
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/types/simple.h"
 #include "gromacs/legacyheaders/typedefs.h"
 
index 7484cdd18235aea7b04382e957164cb4190b8199..4816c101337fd7aacb534e747e6f3077fa2e69c0 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/legacyheaders/types/simple.h"
 
index 8ba9cb00f7a2c5c5f5a7a035cf828eda822e3e31..045f5eb8a802b58d31e26506b9a41b4c1f5d4c1c 100644 (file)
@@ -37,8 +37,6 @@
 #ifndef _GENBORN_ALLVSALL_SSE2_DOUBLE_H
 #define _GENBORN_ALLVSALL_SSE2_DOUBLE_H
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/types/simple.h"
 #include "gromacs/legacyheaders/typedefs.h"
 
index 938b6c16a274025ae4b51c2247af50414757bfc1..b574baea47a38f456efdb791d614af88dd8ebaeb 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/legacyheaders/types/simple.h"
 
index 00d3ec68b61b9f11767f50e4927fc7fc367bbd3a..784b127a40a941228a8211a39f7980e3f6fe803e 100644 (file)
@@ -37,8 +37,6 @@
 #ifndef _GENBORN_ALLVSALL_SSE2_SINGLE_H
 #define _GENBORN_ALLVSALL_SSE2_SINGLE_H
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/types/simple.h"
 #include "gromacs/legacyheaders/typedefs.h"
 
index c8836ae5f53432ced840b8b5565d4898b02c9c3c..54eca2fe79e0fc967ad1d2b94d2b1493e1cabb36 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 0deaf834512b9d16709b1c3f81b7794a4a21cd81..0bf4ea9d6946ac565442f67e81510ab86c353c8e 100644 (file)
@@ -37,8 +37,6 @@
 #ifndef _genborn_sse2_double_h
 #define _genborn_sse2_double_h
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 
 int
index f71b22075ae312d493a76b9c8ace8ad2e950074a..bd5d6097dd7bc5882ae59c6e15a648e032004708 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 9dfc676b8df769e30a7d912721dbba891c991096..6753e0e17f8068226d74d8cb77857220a9d9f267 100644 (file)
@@ -37,8 +37,6 @@
 #ifndef _genborn_sse_h
 #define _genborn_sse_h
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 
 float
index 6b6c44bb02645d58282b319877245748aca8e9af..17d3f713b1e8aabadd9fe817f3569da95ae96abd 100644 (file)
@@ -36,9 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
-
 #include "groupcoord.h"
 #include "gromacs/legacyheaders/network.h"
 #include "gromacs/pbcutil/pbc.h"
index 7ec6e3e712a4c60bf0b69bfda44de5657c9b07cb..90f4de536ecb950dd9b204dc214f8efe26fd1221 100644 (file)
@@ -47,8 +47,6 @@
  * \inlibraryapi
  */
 
-#include "config.h"
-
 #include <stdio.h>
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/types/commrec.h"
index 98b72dda5f7383add34efbf423ddd5f834fc1ce7..6b44531834f143945dda4ed1544fd67d3cda085f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/fileio/tpxio.h"
index c7e6cc0800d67821b019cb7563562932bcf7a263..a53633db6f00b61ae8b0ef9a01719b74204aa128 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/utility/fatalerror.h"
index 5e2b4702a7ff69b567af22ea0468d30c7a1cb0c6..9e1abb9f1fead57be0c7fc3fef8248b2a09832e4 100644 (file)
@@ -39,8 +39,6 @@
 
 #include <algorithm>
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/mdrun.h"
 #include "gromacs/legacyheaders/domdec.h"
index a3d29d00ce48ad94d58758d1064338b76791d8ad..ea59275ec10e2143156eaaf95a5ab72b11285dfc 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index 755671ad7e11ce33c7b105bd5e78d0aad72e5324..84f24ac4380c9883748b43785edce1ef277c4d83 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <float.h>
 #include <stdlib.h>
 #include <string.h>
index d65fd5bd1d36088aad542d5977f0323040d1662c..a6bf3745ca354c50f41a3d657e99e7c63b83db2b 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 #include <float.h>
 #include <math.h>
index 01ac89687860b2794f946d625f688e3a7309cb3b..ba8f2f0140433ba4c04745cb972073274c5fe5fd 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/pbcutil/ishift.h"
 
 #include "nbnxn_kernel_common.h"
index a7c4e38930af2502cb31158981175da4e0452444..abe58155557bd5d76d928d9372b27cfa5db0871b 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/types/nlistheuristics.h"
 
index c48134c8d5ca8ae4da9a1c21f4810edc2c31a4a5..8eb8a70d62ce8ee6fce1f984f2114c002187ef78 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 392c68c8e7235f3be173697a22f2c5129b3c4c8e..8ad27efc6cad5902023bceb3adebcac38d9adfa1 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index 305fac80d27a319c4655cfcf39f25b750c768acb..29010b067ad9b6315ad3bced7cf112e26dd7892d 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/math/vec.h"
index 3b967db0122709172534880cc587151bdc78d827..f5f85e4f8d0743a38723ede0f29b228edead895b 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <stdlib.h>
index 3db4e4dce79b11daf6a3a3d01389a1ee118c878d..ee68bd8ee0fef524bebb043a0ad68fcef87db791 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/typedefs.h"
 #include "gromacs/legacyheaders/force.h"
 #include "gromacs/legacyheaders/names.h"
index a14538b115e993bd0c831b60da21478a5b242103..fba6074500e56346dc0b68343ca39efb5d1c7f62 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index e5b7a3d75fbb022b1a2114419cb3bc320a1ef53f..ad3f4d5c6ef37b4340042402e07d45e4f8efa456 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index 246728091dcd8972e653ac56849025d87ec90ff0..e0d2ee19c60aef83fb58f280b28ab7ef5711709b 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 #include <stdio.h>
 #include "gromacs/legacyheaders/typedefs.h"
index 5a45deedb342e45d83b741eb2a59de82800a387e..5f5d9d58fdb01c9d22a69032c3c4e4bbdee3dc82 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/math/utilities.h"
 #include "gromacs/legacyheaders/typedefs.h"
index 7e7816e1e7ad7fe474f2d4f6e3bd15d62489a5d3..db9a9bb988f3efd6435ef1fb279d5a0b7b227619 100644 (file)
@@ -37,9 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
-
 #include <math.h>
 #include "gromacs/legacyheaders/macros.h"
 #include "gromacs/utility/smalloc.h"
index 6c4c0294d5e4ee679ac3fdfcf159d598022c5a75..39ebeaf2377b59f020d9f251ec39791feca4c1bd 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 8287d12c58af388a91eb92b1fd1512f03c5a9bb5..68c30a18e21851d06d9afc369f04dfbe2f17e311 100644 (file)
@@ -36,9 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
-
 #include <stdio.h>
 #include <math.h>
 
index 8a6267009a2ead8648ee0090a53ea37f1fc3ad98..c6d3b2a3102dd7b504889ad00b0b8703cfe06a58 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "gromacs/legacyheaders/macros.h"
 #include "gromacs/legacyheaders/vcm.h"
 #include "gromacs/math/vec.h"
index a2aa461351c1a1999e7b83aa4448c495670de006..a9df773ec2d081f7718e60f61ce4c9f4615b72e3 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 
 #include "gromacs/legacyheaders/typedefs.h"
index be08c6bb636b309ec8959bb8636ab974802a7f35..38f26e3c1c1d466469b30d6942b7659ab68ca3fb 100644 (file)
@@ -37,8 +37,6 @@
 
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index da8f9a24702ff98a59c325c381493f101c7936f6..62aa867b6bad484d26b477f9c9420dbc48a5b14c 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <string.h>
 #include "gromacs/legacyheaders/force.h"
index 0c94f2321a2372a08fae7af5ddbf1d1afa4a6e57..94dc35bd2b6bbb8d7f9f6c977bda22d5a37242e8 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "gromacs/pbcutil/mshift.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include <algorithm>
index 41a4256f4eae5613e7e767b2da1712950640c9b6..cfdc3be419f2b3b7045f3c12f06c94f37250d43d 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "gromacs/pbcutil/pbc.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <math.h>
 
index fd732c653d32ab31cd1420f84f7eb14c6b355d5a..09f10c043c75ff044963601a5c5bbdc88e4ad7ae 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "gromacs/pbcutil/rmpbc.h"
 
-#include "config.h"
-
 #include "gromacs/fileio/trx.h"
 #include "gromacs/math/vec.h"
 #include "gromacs/pbcutil/mshift.h"
index 1e084858bbb7a117025d75f25ccf1eefe39c07dc..e84ad19714c9de45ac48b6138a26823ec83e0744 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <stdlib.h>
index 3d90b1ae9c8aa6af93414d2510bef57a05a7a6f9..57bc3401c545909c558518b755d4600c6ff3caef 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 
 #include "gromacs/utility/futil.h"
index 5ac13acd8d775599b9848f3ff1f65733a26cbe75..fed78480451ca1e032ad9fdff1ca83e4e0c1043a 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "testutils/testoptions.h"
index 8cc0295babb77e22823157439b40542c89035b53..824a831e18f5e52344a45399a019bcae137406f3 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 /*! \internal \file
  * \brief
  * Separate test of SIMD load/store, before we use them in the SIMD test classes.
index c8429f729f8eeee81fa090dc602ffdec2bb20e68..a53c78999e5ff1fe10d85548e28fe197c493aeb5 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "simd.h"
 
 namespace gmx
index 79ff7783d87e0a6557ddccc062d0c82cf4355aec..23fead9a2b9d800f36e811dee905b48ff0aac421 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "simd4.h"
 
 namespace gmx
index 5d7a92251e589bd64cdb7da83d36c14fb51f45e1..c51c71532fcf960aa4aef037f5637899a1b2f5d6 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/math/utilities.h"
 
index 5ed13a05c7a02caeef31bc36a381428d5aef5e18..17a070b25e587662d10f3cc2fa865e341d89eee0 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/simd/simd.h"
 #include "gromacs/simd/vector_operations.h"
index 78584b72c9b1f7cac495079122adb74cc7b0225e..f0d07034a3e656746d24c48e150e9a3970bcd034 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/math/utilities.h"
 
index e3142f656a62287b35846ceb58a9a603324db474..9535c82a30ddc02274fd952f1a71eadc9da6d55f 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include "simd.h"
 
 /* Some notes on the setup of these tests:
index 68d09637aee8bd2b3c7c9e6e5c23a151f74ab6a1..58c1e6f2af07bb05e602e40cef4e9bb1e9b886f3 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include "gromacs/simd/simd.h"
 #include "gromacs/simd/vector_operations.h"
index 24ba98b3afbb3973f642b3e7a04925f265f9ad01..d77c231f611a09c3c6cdae657dc6f96c88d653b2 100644 (file)
@@ -38,7 +38,6 @@
 
 #include "statistics.h"
 
-#include "config.h"
 #include <math.h>
 
 #include "gromacs/math/vec.h"
index 28a26925e90d7b79377e5efbbf938dbb923e85cd..7baff7bfaca5a48c364878649f7eb668cfbd83d8 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "statistics.h"
 
-#include "config.h"
-
 #include <stdio.h>
 
 #include "gromacs/math/vec.h"
index 0fe76d3b1f697d291d6e590a5d4bee1e3935a407..734b13b5e73a7dcb9da596c706d5949b0ddcbf31 100644 (file)
@@ -41,8 +41,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdlib.h>
 #include <string.h>
index bc0df3faad4dec3d42d13a5958496687c59ceb73..ceb5ec21735ed19b3816d8c562e574892b595989 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <string.h>
index a46b8e51c1c809a1d0fb34c82555bea27f85ef50..7dfe7a93d6e0150efe78e4c841f92d8a06c5514b 100644 (file)
@@ -37,8 +37,6 @@
 /* This file is completely threadsafe - keep it that way! */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdio.h>
 #include <string.h>
index 58921b2cc2198badda41b5659e784ead2a9d768f..c70e194488b7250e9260e5ec8bcc54c0ce1ccd73 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 
 #include "gromacs/legacyheaders/types/inputrec.h"
index 91b860b70ffc4a8e16d260f583be2ed12d033aa6..864c2855905520813381efc2e0a9fd478065583d 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "gromacs/topology/atomprop.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <string.h>
 
index b4440fc13c928c9c259e0fe349e5a7caca425877..615c38a1bf6c9c1b973c740794ca1b7f2ec273d3 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "gromacs/topology/index.h"
 
-#include "config.h"
-
 #include <assert.h>
 #include <ctype.h>
 #include <stdlib.h>
index 9f707ebbc43b1c855930df016e0548e7dba40bdd..622d4e46fe12aedc33370adc5b215e96eb4bbc20 100644 (file)
@@ -36,8 +36,6 @@
 
 #include "gromacs/topology/mtop_util.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index 27b3a0c11e9573f0870604182679602a1e9336d5..35134a5134a9350b26c3256bd9efd8303ee30e1c 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "symtab.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <string.h>
 
index 05d3faa3e0dc18e4a244e382278b9d0d4fad9ff6..8f1a00783183fc85102a083e5b2f0b9d4495efc7 100644 (file)
@@ -38,8 +38,6 @@
 
 #include "gromacs/topology/topsort.h"
 
-#include "config.h"
-
 #include <stdio.h>
 
 #include "gromacs/legacyheaders/types/ifunc.h"
index e67418744d128430ed71e25d2669bebcf4bd21ca..d826b870a8db22340e25068acf4f639bad65de39 100644 (file)
@@ -43,8 +43,6 @@
 
 #include "cmdlinerunner.h"
 
-#include "config.h"
-
 #include "gromacs/analysisdata/paralleloptions.h"
 #include "gromacs/commandline/cmdlinehelpcontext.h"
 #include "gromacs/commandline/cmdlinehelpwriter.h"
index c73d05273a36c0659513717cfb1e3d845fea9953..ffc58420e39ac3d414131e91c29ff920165eabd2 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <string.h>
 #include <stdlib.h>
index 6ab20735e178c507ea99fd3cbd57663c63569c47..bf610b382722e270004a6b8c0875f9032ee7d583 100644 (file)
@@ -43,8 +43,6 @@
 
 #include "runnercommon.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include "gromacs/legacyheaders/oenv.h"
index d6d41aae34494f8d4b30081a22363b0f20b608df..758a5acc479df596d52140a812b8e97adb446c32 100644 (file)
@@ -34,8 +34,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <signal.h>
 #include <stdlib.h>
 #include "gromacs/legacyheaders/typedefs.h"
index 74b2ec032132ab91327b64255dee68476c156e51..680471fdeadcc66bd0bb922798f292b19d2fd621 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index ae840e1f005e4cbcd4f1b3af5e6667b0c20facff..a087852e53fc8d0fba7184782b38b627a8fb27d7 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <stdio.h>
 #include <stdlib.h>
index ccd6763ca86d21277ce719448810de99f72d5425..590e5c8bdbcbd473adcb5a0fe7e2b935041189da 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include <algorithm>
index 89424d59d66ab2064d6cd2c11dd6a39a59bdd767..fdab4e52333c5dbd3393f9f076ff3665a529b72f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 
 #include "gromacs/legacyheaders/macros.h"
index 9975baf1f3fbc824ffa504b87abe2e81cf3c4505..03c0d21513663480739aabb5d5dc0605fe60e02f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index 53cb169be0ba0f943ac6e36f839459f3c7edbb80..0783bb6c849f30665c4d11628d0b5bd5b4d08a3c 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include <algorithm>
index fc80cdfe93aa8ef612ded37bc3691f525b833b79..26fc5bd5fced5b291037db75851631e743b611ec 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <stdlib.h>
 #include <string.h>
index c2d02e1b2fcb1d5f4085d9255bd2a24a847e727a..4af8526f2c6db638d68c9522b13e7dc575136436 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <math.h>
 #include <string.h>
 
index 6d340e568035fe7b21af2bdd2597bab7bc507704..d010cfdcdcfdb3d3d3749aabef9bedb1df325ed3 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <string.h>
 
 #include <algorithm>
index c068628815c99afe64cd3ae11c4240ede92ac728..add052b006ffdafe1b7cd51ef89c60cde7e2b45a 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index dfdadc2a8bd4f4b9e042f904bbb1937121c9f591..86feef1e6957901abee87c74e518baffce50bf5f 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdlib.h>
 #include <string.h>
index aeeb9089c2fd5b2b516d18ad04e87ccee5149b7b..aaf393ae5ecc998dbd348f6593583e1de6f83463 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdlib.h>
 #include <string.h>
 
index 5a043422add0fd19f0c2ffa15aab7fe8da372f95..4890f8fa383ec31cb78f5de4a16c5b9ca7db2d46 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <ctype.h>
 #include <stdio.h>
 #include <stdlib.h>
index 2cbd4a46882706d17b297352c56db42f3f1bc9be..6072f6d3d0debc4a3159134f9b40bdc0e7c188f8 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdlib.h>
 #include <string.h>
index d567c4b6b9124ee45925c118d52daeacfffe52c6..39b4074ec755512d27a0f976bff98c85412bdb80 100644 (file)
@@ -36,8 +36,6 @@
  */
 #include "gmxpre.h"
 
-#include "config.h"
-
 #include <stdio.h>
 #include <stdlib.h>
 #include <string.h>