diff options
author | thierry <thierry@FreeBSD.org> | 2004-12-09 22:45:33 +0000 |
---|---|---|
committer | thierry <thierry@FreeBSD.org> | 2004-12-09 22:45:33 +0000 |
commit | 223000e670ef75cdd74a8ff0824ce20c3b8e2a89 (patch) | |
tree | a04cc29d9cb78de414fb45f4b6db3fe0d54f7f1c /science/gromacs | |
parent | 8fa393a6c2b8341dd451cc134f43ddff01275866 (diff) | |
download | FreeBSD-ports-223000e670ef75cdd74a8ff0824ce20c3b8e2a89.zip FreeBSD-ports-223000e670ef75cdd74a8ff0824ce20c3b8e2a89.tar.gz |
- Fix pkg_plist and unbreak;
- Define USE_LIBTOOL_VER;
- Bump PORTREVISION.
PR: ports/74828
Submitted by: maintainer.
Diffstat (limited to 'science/gromacs')
-rw-r--r-- | science/gromacs/Makefile | 29 | ||||
-rw-r--r-- | science/gromacs/files/patch-src::contrib::Makefile.in | 15 | ||||
-rw-r--r-- | science/gromacs/files/patch-src::gmxlib::Makefile.in | 22 | ||||
-rw-r--r-- | science/gromacs/files/patch-src::kernel::Makefile.in | 15 | ||||
-rw-r--r-- | science/gromacs/files/patch-src::mdlib::Makefile.in | 15 | ||||
-rw-r--r-- | science/gromacs/files/patch-src::ngmx::Makefile.in | 15 | ||||
-rw-r--r-- | science/gromacs/files/patch-src::tools::Makefile.in | 15 | ||||
-rw-r--r-- | science/gromacs/pkg-plist | 947 |
8 files changed, 589 insertions, 484 deletions
diff --git a/science/gromacs/Makefile b/science/gromacs/Makefile index 13176fc..7397bc3 100644 --- a/science/gromacs/Makefile +++ b/science/gromacs/Makefile @@ -7,6 +7,7 @@ PORTNAME= gromacs PORTVERSION= 3.2.1 +PORTREVISION= 1 CATEGORIES= science MASTER_SITES= ftp://ftp.gromacs.org/pub/gromacs/ @@ -17,14 +18,13 @@ COMMENT= Compute molecular dynamics LIB_DEPENDS= fftw:${PORTSDIR}/math/fftw:install .endif .ifdef WITH_MPI -BUILD_DEPENDS= ${LOCALPREFIX}/mpich/bin/mpicc:${PORTSDIR}/net/mpich:install -RUN_DEPENDS= ${LOCALPREFIX}/mpich/bin/mpicc:${PORTSDIR}/net/mpich:install +BUILD_DEPENDS= ${LOCALBASE}/mpich/bin/mpicc:${PORTSDIR}/net/mpich +RUN_DEPENDS= ${LOCALBASE}/mpich/bin/mpicc:${PORTSDIR}/net/mpich .endif -BROKEN= Broken pkg-plist - USE_GMAKE= yes -GNU_CONFIGURE= yes +USE_LIBTOOL_VER= 15 +INSTALLS_SHLIB= yes CONFIGURE_TARGET= --build=${MACHINE_ARCH}-portbld-freebsd${OSREL} CONFIGURE_ENV= CPPFLAGS=-I${LOCALBASE}/include LDFLAGS=-L${LOCALBASE}/lib CONFIGURE_ARGS= --exec-prefix=${PREFIX} @@ -33,9 +33,9 @@ PLIST_SUB= BUILD=${MACHINE_ARCH}-portbld-freebsd${OSREL} .ifndef WITHOUT_FFTW .ifdef WITH_FLOAT -IGNORE= Cannot currently build with fftw and single precision floating point +IGNORE= Cannot currently build with fftw and single precision floating point .elifdef WITH_MPI -IGNORE= Cannot currently build with fftw and mpi support +IGNORE= Cannot currently build with fftw and mpi support .endif .endif @@ -48,20 +48,23 @@ CONFIGURE_ARGS+= --with-x USE_XLIB= yes .endif -.ifdef WITHOUT_FFTW -CONFIGURE_ARGS+= --without-fftw +.ifndef WITH_FLOAT +CONFIGURE_ARGS+= --disable-float --program-suffix= +PLIST_SUB+= SUFFIX_D=_d SUFFIX_DOUBLE=_double +.else +PLIST_SUB+= SUFFIX_D= SUFFIX_DOUBLE= .endif -.ifndef WITHOUT_FLOAT -CONFIGURE_ARGS+= --disable-float +.ifdef WITHOUT_FFTW +CONFIGURE_ARGS+= --without-fftw .endif .ifdef WITH_MPI CONFIGURE_ARGS+= --enable-mpi CONFIGURE_ENV+= MPICC=${PREFIX}/mpich/bin/mpicc -PLIST_SUB+= WITH_MPI= _MPI=_mpi +PLIST_SUB+= WITH_MPI= SUFFIX_MPI=_mpi WITHOUT_MPI="@comment " .else -PLIST_SUB+= WITH_MPI="@comment " SUFFIX_MPI= +PLIST_SUB+= WITH_MPI="@comment " SUFFIX_MPI= WITHOUT_MPI= .endif MAN1= anadock.1 \ diff --git a/science/gromacs/files/patch-src::contrib::Makefile.in b/science/gromacs/files/patch-src::contrib::Makefile.in new file mode 100644 index 0000000..aefac2f --- /dev/null +++ b/science/gromacs/files/patch-src::contrib::Makefile.in @@ -0,0 +1,15 @@ +--- src/contrib/Makefile.in.orig Mon Mar 1 20:49:01 2004 ++++ src/contrib/Makefile.in Thu Dec 9 19:54:56 2004 +@@ -307,10 +307,10 @@ + @AMDEP_TRUE@ ./$(DEPDIR)/sigeps.Po + COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +-LTCOMPILE = $(LIBTOOL) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ ++LTCOMPILE = $(LIBTOOL) --mode=compile --tag=CC $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ + $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) + CCLD = $(CC) +-LINK = $(LIBTOOL) --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ ++LINK = $(LIBTOOL) --mode=link --tag=CC $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ + $(AM_LDFLAGS) $(LDFLAGS) -o $@ + F77COMPILE = $(F77) $(AM_FFLAGS) $(FFLAGS) + LTF77COMPILE = $(LIBTOOL) --mode=compile $(F77) $(AM_FFLAGS) $(FFLAGS) diff --git a/science/gromacs/files/patch-src::gmxlib::Makefile.in b/science/gromacs/files/patch-src::gmxlib::Makefile.in new file mode 100644 index 0000000..ee1a363 --- /dev/null +++ b/science/gromacs/files/patch-src::gmxlib::Makefile.in @@ -0,0 +1,22 @@ +--- src/gmxlib/Makefile.in.orig Mon Mar 1 20:49:02 2004 ++++ src/gmxlib/Makefile.in Thu Dec 9 00:11:00 2004 +@@ -292,16 +292,16 @@ + @AMDEP_TRUE@ ./$(DEPDIR)/xtcio.Plo ./$(DEPDIR)/xvgr.Plo + COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +-LTCOMPILE = $(LIBTOOL) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ ++LTCOMPILE = $(LIBTOOL) --mode=compile --tag=CC $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ + $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) + CCLD = $(CC) +-LINK = $(LIBTOOL) --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ ++LINK = $(LIBTOOL) --mode=link --tag=CC $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ + $(AM_LDFLAGS) $(LDFLAGS) -o $@ + F77COMPILE = $(F77) $(AM_FFLAGS) $(FFLAGS) + LTF77COMPILE = $(LIBTOOL) --mode=compile $(F77) $(AM_FFLAGS) $(FFLAGS) + F77LD = $(F77) + CCASCOMPILE = $(CCAS) $(AM_CCASFLAGS) $(CCASFLAGS) +-LTCCASCOMPILE = $(LIBTOOL) --mode=compile $(CCAS) $(AM_CCASFLAGS) \ ++LTCCASCOMPILE = $(LIBTOOL) --mode=compile --tag=CC $(CCAS) $(AM_CCASFLAGS) \ + $(CCASFLAGS) + DIST_SOURCES = $(libgmx@LIBSUFFIX@_la_SOURCES) \ + $(EXTRA_libgmx@LIBSUFFIX@_la_SOURCES) diff --git a/science/gromacs/files/patch-src::kernel::Makefile.in b/science/gromacs/files/patch-src::kernel::Makefile.in new file mode 100644 index 0000000..731760e --- /dev/null +++ b/science/gromacs/files/patch-src::kernel::Makefile.in @@ -0,0 +1,15 @@ +--- src/kernel/Makefile.in.orig Mon Mar 1 20:49:03 2004 ++++ src/kernel/Makefile.in Thu Dec 9 00:33:06 2004 +@@ -367,10 +367,10 @@ + @AMDEP_TRUE@ ./$(DEPDIR)/xutils.Po + COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +-LTCOMPILE = $(LIBTOOL) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ ++LTCOMPILE = $(LIBTOOL) --mode=compile --tag=CC $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ + $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) + CCLD = $(CC) +-LINK = $(LIBTOOL) --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ ++LINK = $(LIBTOOL) --mode=link --tag=CC $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ + $(AM_LDFLAGS) $(LDFLAGS) -o $@ + DIST_SOURCES = $(ffscan_SOURCES) $(gmxcheck_SOURCES) gmxdump.c \ + $(grompp_SOURCES) luck.c $(mdrun_SOURCES) $(pdb2gmx_SOURCES) \ diff --git a/science/gromacs/files/patch-src::mdlib::Makefile.in b/science/gromacs/files/patch-src::mdlib::Makefile.in new file mode 100644 index 0000000..8f8dff3 --- /dev/null +++ b/science/gromacs/files/patch-src::mdlib::Makefile.in @@ -0,0 +1,15 @@ +--- src/mdlib/Makefile.in.orig Mon Mar 1 20:49:03 2004 ++++ src/mdlib/Makefile.in Thu Dec 9 00:22:03 2004 +@@ -233,10 +233,10 @@ + @AMDEP_TRUE@ ./$(DEPDIR)/vcm.Plo ./$(DEPDIR)/wnblist.Plo + COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +-LTCOMPILE = $(LIBTOOL) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ ++LTCOMPILE = $(LIBTOOL) --mode=compile --tag=CC $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ + $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) + CCLD = $(CC) +-LINK = $(LIBTOOL) --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ ++LINK = $(LIBTOOL) --mode=link --tag=CC $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ + $(AM_LDFLAGS) $(LDFLAGS) -o $@ + F77COMPILE = $(F77) $(AM_FFLAGS) $(FFLAGS) + LTF77COMPILE = $(LIBTOOL) --mode=compile $(F77) $(AM_FFLAGS) $(FFLAGS) diff --git a/science/gromacs/files/patch-src::ngmx::Makefile.in b/science/gromacs/files/patch-src::ngmx::Makefile.in new file mode 100644 index 0000000..49989cd --- /dev/null +++ b/science/gromacs/files/patch-src::ngmx::Makefile.in @@ -0,0 +1,15 @@ +--- src/ngmx/Makefile.in.orig Mon Mar 1 20:49:04 2004 ++++ src/ngmx/Makefile.in Thu Dec 9 19:53:57 2004 +@@ -272,10 +272,10 @@ + @AMDEP_TRUE@ ./$(DEPDIR)/xrama.Po ./$(DEPDIR)/xutil.Po + COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +-LTCOMPILE = $(LIBTOOL) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ ++LTCOMPILE = $(LIBTOOL) --mode=compile --tag=CC $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ + $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) + CCLD = $(CC) +-LINK = $(LIBTOOL) --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ ++LINK = $(LIBTOOL) --mode=link --tag=CC $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ + $(AM_LDFLAGS) $(LDFLAGS) -o $@ + DIST_SOURCES = $(dlg_SOURCES) $(gmxlogo_SOURCES) $(highway_SOURCES) \ + $(ngmx_SOURCES) $(scrollw_SOURCES) $(showcol_SOURCES) \ diff --git a/science/gromacs/files/patch-src::tools::Makefile.in b/science/gromacs/files/patch-src::tools::Makefile.in new file mode 100644 index 0000000..7f38409 --- /dev/null +++ b/science/gromacs/files/patch-src::tools::Makefile.in @@ -0,0 +1,15 @@ +--- src/tools/Makefile.in.orig Mon Mar 1 20:49:06 2004 ++++ src/tools/Makefile.in Thu Dec 9 19:35:43 2004 +@@ -744,10 +744,10 @@ + @AMDEP_TRUE@ ./$(DEPDIR)/xpm2ps.Po + COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +-LTCOMPILE = $(LIBTOOL) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ ++LTCOMPILE = $(LIBTOOL) --mode=compile --tag=CC $(CC) $(DEFS) $(DEFAULT_INCLUDES) \ + $(INCLUDES) $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) + CCLD = $(CC) +-LINK = $(LIBTOOL) --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ ++LINK = $(LIBTOOL) --mode=link --tag=CC $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ + $(AM_LDFLAGS) $(LDFLAGS) -o $@ + DIST_SOURCES = $(libgmxana@LIBSUFFIX@_la_SOURCES) $(anadock_SOURCES) \ + average.c $(cdist_SOURCES) $(disco_SOURCES) do_dssp.c \ diff --git a/science/gromacs/pkg-plist b/science/gromacs/pkg-plist index 8d8b3e0..07fd083 100644 --- a/science/gromacs/pkg-plist +++ b/science/gromacs/pkg-plist @@ -1,69 +1,47 @@ -lib/libgmx%%SUFFIX_MPI%%.la -lib/libgmx%%SUFFIX_MPI%%.a -lib/libmd%%SUFFIX_MPI%%.la -lib/libmd%%SUFFIX_MPI%%.a -lib/libgmxana%%SUFFIX_MPI%%.la -%%WITH_MPI%%lib/libgmxana%%SUFFIX_MPI%%.a -lib/libgmxana.a -%%WITHOUT_X%%bin/ngmx -%%WITHOUT_X%%bin/xrama -%%WITHOUT_X%%bin/highway -bin/grompp -bin/mdrun -bin/tpbconv -bin/pdb2gmx -bin/protonate -bin/luck -bin/gmxdump -bin/gmxcheck -bin/x2top -bin/ffscan +bin/GMXRC +bin/GMXRC.bash +bin/GMXRC.csh +bin/GMXRC.zsh +bin/anadock bin/average +bin/cdist +bin/completion.bash +bin/completion.csh +bin/completion.zsh +bin/disco bin/do_dssp bin/editconf bin/eneconv -bin/genbox -bin/genconf -bin/genpr -bin/make_ndx -bin/mk_angndx -bin/trjcat -bin/trjconv -bin/trjorder -bin/wheel -bin/xpm2ps -bin/genion -bin/anadock -bin/cdist -bin/disco -bin/g_angle -bin/make_edi -bin/g_analyze +bin/ffscan bin/g_anaeig +bin/g_analyze +bin/g_angle bin/g_bond bin/g_bundle bin/g_chi bin/g_cluster +bin/g_clustsize bin/g_confrms bin/g_covar bin/g_density -bin/g_dih bin/g_dielectric +bin/g_dih bin/g_dipoles bin/g_disre bin/g_dist bin/g_dyndom bin/g_enemat bin/g_energy -bin/g_lie bin/g_filter bin/g_gyrate bin/g_h2order bin/g_hbond bin/g_helix +bin/g_lie +bin/g_mdmat bin/g_mindist -bin/g_msd bin/g_morph +bin/g_msd bin/g_nmeig bin/g_nmens bin/g_order @@ -81,473 +59,500 @@ bin/g_sorient bin/g_tcaf bin/g_traj bin/g_velacc -bin/g_clustsize -bin/g_mdmat bin/g_wham -bin/GMXRC -bin/GMXRC.csh -bin/GMXRC.bash -bin/GMXRC.zsh -bin/completion.csh -bin/completion.bash -bin/completion.zsh -share/gromacs/top/ffgmx.itp -share/gromacs/top/ffgmxnb.itp -share/gromacs/top/ffgmxbon.itp -share/gromacs/top/ffgmx.atp -share/gromacs/top/ffgmx.hdb -share/gromacs/top/ffgmx.n2t -share/gromacs/top/ffgmx.rtp -share/gromacs/top/ffgmx-c.tdb -share/gromacs/top/ffgmx-n.tdb -share/gromacs/top/ffgmx2.itp -share/gromacs/top/ffgmx2nb.itp -share/gromacs/top/ffgmx2bon.itp -share/gromacs/top/ffgmx2.atp -share/gromacs/top/ffgmx2.hdb -share/gromacs/top/ffgmx2.rtp -share/gromacs/top/ffgmx2-c.tdb -share/gromacs/top/ffgmx2-n.tdb -share/gromacs/top/ffG43a1.itp -share/gromacs/top/ffG43a1nb.itp -share/gromacs/top/ffG43a1bon.itp -share/gromacs/top/ffG43a1.atp -share/gromacs/top/ffG43a1.hdb -share/gromacs/top/ffG43a1.rtp -share/gromacs/top/ffG43a1-c.tdb -share/gromacs/top/ffG43a1-n.tdb -share/gromacs/top/ffG43a2.itp -share/gromacs/top/ffG43a2nb.itp -share/gromacs/top/ffG43a2bon.itp -share/gromacs/top/ffG43a2.atp -share/gromacs/top/ffG43a2.hdb -share/gromacs/top/ffG43a2.rtp -share/gromacs/top/ffG43a2-c.tdb -share/gromacs/top/ffG43a2-n.tdb -share/gromacs/top/ffG43b1.itp -share/gromacs/top/ffG43b1nb.itp -share/gromacs/top/ffG43b1bon.itp -share/gromacs/top/ffG43b1.atp -share/gromacs/top/ffG43b1.hdb -share/gromacs/top/ffG43b1.rtp -share/gromacs/top/ffG43b1-c.tdb -share/gromacs/top/ffG43b1-n.tdb -share/gromacs/top/ffgmx.ddb -share/gromacs/top/ffgmx2.ddb -share/gromacs/top/ffG43a1.ddb -share/gromacs/top/ffG43a2.ddb -share/gromacs/top/ffG43b1.ddb -share/gromacs/top/ffoplsaa.atp -share/gromacs/top/ffoplsaa.itp -share/gromacs/top/ffoplsaabon.itp -share/gromacs/top/ffoplsaanb.itp -share/gromacs/top/ffoplsaa.hdb -share/gromacs/top/ffoplsaa-n.tdb -share/gromacs/top/ffoplsaa-c.tdb -share/gromacs/top/ffoplsaa.rtp -share/gromacs/top/ffoplsaa.ddb -share/gromacs/top/1mlg.itp -share/gromacs/top/2mlg.itp -share/gromacs/top/benzamide.itp -share/gromacs/top/bondadd.itp -share/gromacs/top/buck.itp -share/gromacs/top/decane.itp -share/gromacs/top/dlg.itp -share/gromacs/top/dmso.itp -share/gromacs/top/fa.itp -share/gromacs/top/ff_dum.itp -share/gromacs/top/flexspc.itp -share/gromacs/top/flexspce.itp -share/gromacs/top/flexwat-ferguson.itp -share/gromacs/top/h2p4o13.itp -share/gromacs/top/h2p8o25.itp -share/gromacs/top/h2po4.itp -share/gromacs/top/ions.itp -share/gromacs/top/methanol.itp -share/gromacs/top/spc.itp -share/gromacs/top/spce.itp -share/gromacs/top/tfe.itp -share/gromacs/top/tip3p.itp -share/gromacs/top/tip4p.itp -share/gromacs/top/urea.itp -share/gromacs/top/dgsolv.dat -share/gromacs/top/dec50.gro -share/gromacs/top/dmso.gro -share/gromacs/top/spc216.gro -share/gromacs/top/tip4p.gro -share/gromacs/top/urea+h2o.gro -share/gromacs/top/aminoacids.dat -share/gromacs/top/atommass.dat -share/gromacs/top/bromacs.dat -share/gromacs/top/ca-shift.dat -share/gromacs/top/cb-shift.dat -share/gromacs/top/co-shift.dat -share/gromacs/top/edissoc.dat -share/gromacs/top/FF.dat -share/gromacs/top/ss.map -share/gromacs/top/gurgle.dat -share/gromacs/top/ha-shift.dat -share/gromacs/top/links.dat -share/gromacs/top/phbres.dat -share/gromacs/top/random.dat -share/gromacs/top/refi_aa.dat -share/gromacs/top/specbond.dat -share/gromacs/top/surface.dat -share/gromacs/top/vdwradii.dat -share/gromacs/top/xlateat.dat -share/gromacs/top/export.dlg -share/gromacs/top/bonds.dlg -share/gromacs/top/ps.m2p -share/gromacs/top/table6-10.xvg -share/gromacs/top/table6-11.xvg -share/gromacs/top/table6-12.xvg -share/gromacs/top/table6-8.xvg -share/gromacs/top/table6-9.xvg -share/gromacs/top/atom_nom.tbl -share/gromacs/top/gromacs.dtd -share/gromacs/top/tip5p.gro -share/gromacs/top/tip5p.itp -share/gromacs/top/sw.itp -share/gromacs/tutor/nmr1/conf.gro -share/gromacs/tutor/nmr1/grompp.mdp -share/gromacs/tutor/nmr1/pep.pdb -share/gromacs/tutor/nmr1/topol.top -share/gromacs/tutor/nmr2/conf.gro -share/gromacs/tutor/nmr2/genconf.gcp -share/gromacs/tutor/nmr2/grompp.mdp -share/gromacs/tutor/nmr2/pep.pdb -share/gromacs/tutor/nmr2/topol.top -share/gromacs/tutor/speptide/em.mdp -share/gromacs/tutor/speptide/full.mdp -share/gromacs/tutor/speptide/pr.mdp -share/gromacs/tutor/speptide/speptide.pdb -share/gromacs/tutor/water/index.ndx -share/gromacs/tutor/water/conf.gro -share/gromacs/tutor/water/spc216.pdb -share/gromacs/tutor/water/grompp.mdp -share/gromacs/tutor/water/topol.top -share/gromacs/tutor/gmxdemo/cpeptide.pdb -share/gromacs/tutor/gmxdemo/demo -share/gromacs/tutor/methanol/index.ndx -share/gromacs/tutor/methanol/conf.gro -share/gromacs/tutor/methanol/methanol.pdb -share/gromacs/tutor/methanol/grompp.mdp -share/gromacs/tutor/methanol/topol.top -share/gromacs/tutor/methanol/methanol.itp -share/gromacs/tutor/mixed/index.ndx -share/gromacs/tutor/mixed/conf.gro -share/gromacs/tutor/mixed/mixed.pdb -share/gromacs/tutor/mixed/grompp.mdp -share/gromacs/tutor/mixed/topol.top -share/gromacs/tutor/cleanit -share/gromacs/template/template.c -share/gromacs/template/README -share/gromacs/template/Makefile.%%BUILD%% -share/gromacs/html/online.html -share/gromacs/html/gmxfaq.html -share/gromacs/html/images/features.gif -share/gromacs/html/images/flow_leftrightup.gif -share/gromacs/html/images/flow_vrule.gif -share/gromacs/html/images/flow_down.gif -share/gromacs/html/images/flow_leftup.gif -share/gromacs/html/images/links.gif -share/gromacs/html/images/articles.gif -share/gromacs/html/images/flow_downleft.gif -share/gromacs/html/images/flow_right+left.gif -share/gromacs/html/images/mail.gif -share/gromacs/html/images/bench.gif -share/gromacs/html/images/flow_hline.gif -share/gromacs/html/images/flow_right.gif -share/gromacs/html/images/manual.gif -share/gromacs/html/images/charts_down.gif -share/gromacs/html/images/flow_left.gif -share/gromacs/html/images/flow_rightleftdown.gif -share/gromacs/html/images/gmxlogo_small.jpg -share/gromacs/html/images/charts_up.gif -share/gromacs/html/images/faq.gif -share/gromacs/html/images/flow_leftright.gif -share/gromacs/html/images/flow_uprightleft.gif -share/gromacs/html/images/software.gif -share/gromacs/html/images/flow_leftrightdown.gif -share/gromacs/html/images/flow_vline.gif -share/gromacs/html/images/topologies.gif -share/gromacs/html/images/plotje.gif -share/gromacs/html/images/xvgr.gif -share/gromacs/html/images/1ctf-0.jpg -share/gromacs/html/images/1ctf-0.2.jpg -share/gromacs/html/images/1ctf-0.5.jpg -share/gromacs/html/images/1ctf-1.jpg -share/gromacs/html/images/1ctf-4.jpg -share/gromacs/html/images/1ctf-10.jpg -share/gromacs/html/online/dat.html -share/gromacs/html/online/g_disre.html -share/gromacs/html/online/g_sorient.html -share/gromacs/html/online/ndx.html -share/gromacs/html/online/dlg.html -share/gromacs/html/online/g_dist.html -share/gromacs/html/online/g_tcaf.html -share/gromacs/html/online/ngmx.html -share/gromacs/html/online/do_dssp.html -share/gromacs/html/online/g_dyndom.html -share/gromacs/html/online/g_traj.html -share/gromacs/html/online/edi.html -share/gromacs/html/online/g_enemat.html -share/gromacs/html/online/g_velacc.html -share/gromacs/html/online/options.html -share/gromacs/html/online/editconf.html -share/gromacs/html/online/g_energy.html -share/gromacs/html/online/genbox.html -share/gromacs/html/online/out.html -share/gromacs/html/online/edo.html -share/gromacs/html/online/g_gyrate.html -share/gromacs/html/online/genconf.html -share/gromacs/html/online/pdb.html -share/gromacs/html/online/edr.html -share/gromacs/html/online/g_h2order.html -share/gromacs/html/online/genion.html -share/gromacs/html/online/pdb2gmx.html -share/gromacs/html/online/ene.html -share/gromacs/html/online/g_hbond.html -share/gromacs/html/online/genpr.html -share/gromacs/html/online/protonate.html -share/gromacs/html/online/eneconv.html -share/gromacs/html/online/g_helix.html -share/gromacs/html/online/getting_started.html -share/gromacs/html/online/rtp.html -share/gromacs/html/online/eps.html -share/gromacs/html/online/g_lie.html -share/gromacs/html/online/gmxcheck.html -share/gromacs/html/online/tex.html -share/gromacs/html/online/files.html -share/gromacs/html/online/g_mdmat.html -share/gromacs/html/online/gmxdump.html -share/gromacs/html/online/top.html -share/gromacs/html/online/flow.html -share/gromacs/html/online/g_mindist.html -share/gromacs/html/online/gro.html -share/gromacs/html/online/tpa.html -share/gromacs/html/online/g87.html -share/gromacs/html/online/g_morph.html -share/gromacs/html/online/grompp.html -share/gromacs/html/online/tpb.html -share/gromacs/html/online/g96.html -share/gromacs/html/online/g_msd.html -share/gromacs/html/online/hat.html -share/gromacs/html/online/tpbconv.html -share/gromacs/html/online/g_anaeig.html -share/gromacs/html/online/g_nmeig.html -share/gromacs/html/online/highway.html -share/gromacs/html/online/tpr.html -share/gromacs/html/online/g_analyze.html -share/gromacs/html/online/g_nmens.html -share/gromacs/html/online/include_bot.html -share/gromacs/html/online/trj.html -share/gromacs/html/online/g_angle.html -share/gromacs/html/online/g_order.html -share/gromacs/html/online/include_top.html -share/gromacs/html/online/trjcat.html -share/gromacs/html/online/g_bond.html -share/gromacs/html/online/g_potential.html -share/gromacs/html/online/itp.html -share/gromacs/html/online/trjconv.html -share/gromacs/html/online/g_bundle.html -share/gromacs/html/online/g_rama.html -share/gromacs/html/online/log.html -share/gromacs/html/online/trjorder.html -share/gromacs/html/online/g_chi.html -share/gromacs/html/online/g_rdf.html -share/gromacs/html/online/m2p.html -share/gromacs/html/online/trr.html -share/gromacs/html/online/g_cluster.html -share/gromacs/html/online/g_rms.html -share/gromacs/html/online/make_ndx.html -share/gromacs/html/online/wheel.html -share/gromacs/html/online/g_confrms.html -share/gromacs/html/online/g_rmsdist.html -share/gromacs/html/online/map.html -share/gromacs/html/online/x2top.html -share/gromacs/html/online/g_covar.html -share/gromacs/html/online/g_rmsf.html -share/gromacs/html/online/mdp.html -share/gromacs/html/online/xpm.html -share/gromacs/html/online/g_density.html -share/gromacs/html/online/g_rotacf.html -share/gromacs/html/online/mdp_opt.html -share/gromacs/html/online/xpm2ps.html -share/gromacs/html/online/g_dielectric.html -share/gromacs/html/online/g_saltbr.html -share/gromacs/html/online/mdrun.html -share/gromacs/html/online/xrama.html -share/gromacs/html/online/g_dih.html -share/gromacs/html/online/g_sas.html -share/gromacs/html/online/mk_angndx.html -share/gromacs/html/online/xtc.html -share/gromacs/html/online/g_dipoles.html -share/gromacs/html/online/g_sgangle.html -share/gromacs/html/online/mtx.html -share/gromacs/html/online/xvg.html -share/gromacs/html/online/style.css -share/gromacs/html/online/water.html -share/gromacs/html/online/gmxdemo.html -share/gromacs/html/online/speptide.html -share/gromacs/html/online/yourown.html -share/gromacs/html/online/methanol.html -share/gromacs/html/online/mixed.html -share/gromacs/html/online/protunf.html +bin/genbox +bin/genconf +bin/genion +bin/genpr +bin/gmxcheck +bin/gmxdump +bin/grompp +%%WITHOUT_X%%bin/highway +bin/luck +bin/make_edi +bin/make_ndx +bin/mdrun +bin/mk_angndx +%%WITHOUT_X%%bin/ngmx +bin/pdb2gmx +bin/protonate +bin/tpbconv +bin/trjcat +bin/trjconv +bin/trjorder +bin/wheel +bin/x2top +bin/xpm2ps +%%WITHOUT_X%%bin/xrama include/gromacs/3dview.h -include/gromacs/do_md.h -include/gromacs/invblock.h -include/gromacs/nrjac.h -include/gromacs/tpxio.h include/gromacs/assert.h -include/gromacs/dihre.h -include/gromacs/nrnb.h -include/gromacs/sheader.h -include/gromacs/transfer.h include/gromacs/atomprop.h -include/gromacs/dummies.h -include/gromacs/ns.h -include/gromacs/shift.h -include/gromacs/trnio.h include/gromacs/axp_asm.h +include/gromacs/block_tx.h +include/gromacs/bondf.h +include/gromacs/calcgrid.h +include/gromacs/calch.h +include/gromacs/calcmu.h +include/gromacs/callf77.h +include/gromacs/confio.h +include/gromacs/constr.h +include/gromacs/copyrite.h +include/gromacs/detectcpu.h +include/gromacs/dihre.h +include/gromacs/disre.h +include/gromacs/do_fit.h +include/gromacs/do_md.h +include/gromacs/dummies.h include/gromacs/ebin.h -include/gromacs/macros.h -include/gromacs/nsb.h -include/gromacs/shift_util.h -include/gromacs/txtdump.h include/gromacs/edsam.h -include/gromacs/magic.h -include/gromacs/nsgrid.h -include/gromacs/typedefs.h -include/gromacs/block_tx.h include/gromacs/enxio.h -include/gromacs/main.h -include/gromacs/pbc.h -include/gromacs/smalloc.h -include/gromacs/update.h -include/gromacs/bondf.h include/gromacs/ewald.h -include/gromacs/maths.h -include/gromacs/pdbio.h -include/gromacs/sortwater.h -include/gromacs/utils.h include/gromacs/ewald_util.h -include/gromacs/matio.h -include/gromacs/pdebug.h -include/gromacs/split.h -include/gromacs/vcm.h -include/gromacs/calcgrid.h include/gromacs/fatal.h -include/gromacs/mdatoms.h -include/gromacs/physics.h -include/gromacs/vec.h -include/gromacs/calch.h include/gromacs/ffscanf.h -include/gromacs/mdebin.h -include/gromacs/pme.h -include/gromacs/statusio.h -include/gromacs/viewit.h -include/gromacs/calcmu.h include/gromacs/fftgrid.h -include/gromacs/mdrun.h -include/gromacs/pppm.h -include/gromacs/statutil.h -include/gromacs/callf77.h include/gromacs/fftw_wrapper.h -include/gromacs/gmx_ana.h -include/gromacs/princ.h -include/gromacs/wgms.h -include/gromacs/gmx_system_xdr.h include/gromacs/filenm.h -include/gromacs/pull.h -include/gromacs/rdgroup.h -include/gromacs/strdb.h -include/gromacs/wman.h include/gromacs/force.h -include/gromacs/string2.h -include/gromacs/writeps.h -include/gromacs/gmxcomplex.h include/gromacs/futil.h -include/gromacs/metacode.h -include/gromacs/random.h -include/gromacs/struc2.h -include/gromacs/x86_3dnow.h include/gromacs/gbutil.h +include/gromacs/gmx_ana.h include/gromacs/gmx_random.h -include/gromacs/rbin.h -include/gromacs/detectcpu.h -include/gromacs/tgroup.h -include/gromacs/mshift.h -include/gromacs/symtab.h -include/gromacs/x86_sse.h -include/gromacs/confio.h +include/gromacs/gmx_system_xdr.h +include/gromacs/gmxcomplex.h include/gromacs/gmxfio.h -include/gromacs/xdrf.h -include/gromacs/constr.h include/gromacs/grompp.h -include/gromacs/names.h -include/gromacs/readcomp.h -include/gromacs/xtcio.h -include/gromacs/copyrite.h include/gromacs/gstat.h -include/gromacs/network.h -include/gromacs/readinp.h -include/gromacs/sysstuff.h -include/gromacs/xvgr.h include/gromacs/index.h -include/gromacs/mvdata.h -include/gromacs/disre.h -include/gromacs/orires.h -include/gromacs/x86_sse2.h include/gromacs/init.h +include/gromacs/invblock.h +include/gromacs/macros.h +include/gromacs/magic.h +include/gromacs/main.h +include/gromacs/maths.h +include/gromacs/matio.h +include/gromacs/mdatoms.h +include/gromacs/mdebin.h +include/gromacs/mdrun.h +include/gromacs/metacode.h +include/gromacs/mshift.h +include/gromacs/mvdata.h +include/gromacs/names.h +include/gromacs/network.h include/gromacs/nr.h -include/gromacs/reorder.h -include/gromacs/tags.h -include/gromacs/do_fit.h include/gromacs/nrama.h -include/gromacs/rmpbc.h +include/gromacs/nrjac.h +include/gromacs/nrnb.h +include/gromacs/ns.h +include/gromacs/nsb.h +include/gromacs/nsgrid.h +include/gromacs/orires.h +include/gromacs/pbc.h +include/gromacs/pdbio.h +include/gromacs/pdebug.h +include/gromacs/physics.h +include/gromacs/pme.h include/gromacs/ppc_altivec.h +include/gromacs/pppm.h +include/gromacs/princ.h +include/gromacs/pull.h +include/gromacs/random.h +include/gromacs/rbin.h +include/gromacs/rdgroup.h +include/gromacs/readcomp.h +include/gromacs/readinp.h +include/gromacs/reorder.h +include/gromacs/rmpbc.h +include/gromacs/sheader.h +include/gromacs/shift.h +include/gromacs/shift_util.h +include/gromacs/smalloc.h +include/gromacs/sortwater.h +include/gromacs/split.h +include/gromacs/statusio.h +include/gromacs/statutil.h +include/gromacs/strdb.h +include/gromacs/string2.h +include/gromacs/struc2.h +include/gromacs/symtab.h +include/gromacs/sysstuff.h +include/gromacs/tags.h +include/gromacs/tgroup.h +include/gromacs/tpxio.h +include/gromacs/transfer.h +include/gromacs/trnio.h +include/gromacs/txtdump.h +include/gromacs/typedefs.h include/gromacs/types/atoms.h -include/gromacs/types/edsams.h -include/gromacs/types/forcerec.h -include/gromacs/types/ifunc.h -include/gromacs/types/mdatom.h -include/gromacs/types/nsborder.h -include/gromacs/types/simple.h include/gromacs/types/block.h -include/gromacs/types/energy.h -include/gromacs/types/graph.h -include/gromacs/types/inputrec.h -include/gromacs/types/nblist.h -include/gromacs/types/nsgrid.h -include/gromacs/types/symtab.h include/gromacs/types/commrec.h +include/gromacs/types/edsams.h +include/gromacs/types/energy.h include/gromacs/types/enums.h -include/gromacs/types/group.h -include/gromacs/types/ishift.h -include/gromacs/types/nbslist.h -include/gromacs/types/parm.h -include/gromacs/types/topology.h include/gromacs/types/fcdata.h include/gromacs/types/filenm.h +include/gromacs/types/forcerec.h +include/gromacs/types/graph.h +include/gromacs/types/group.h include/gromacs/types/idef.h +include/gromacs/types/ifunc.h +include/gromacs/types/inputrec.h +include/gromacs/types/ishift.h include/gromacs/types/matrix.h +include/gromacs/types/mdatom.h +include/gromacs/types/nblist.h +include/gromacs/types/nbslist.h include/gromacs/types/nrnb.h -include/gromacs/types/trx.h +include/gromacs/types/nsborder.h +include/gromacs/types/nsgrid.h +include/gromacs/types/parm.h +include/gromacs/types/simple.h include/gromacs/types/state.h -@dirrm share/gromacs/tutor/water -@dirrm share/gromacs/tutor/speptide -@dirrm share/gromacs/tutor/nmr2 -@dirrm share/gromacs/tutor/nmr1 -@dirrm share/gromacs/tutor/mixed -@dirrm share/gromacs/tutor/methanol -@dirrm share/gromacs/tutor/gmxdemo -@dirrm share/gromacs/tutor -@dirrm share/gromacs/top -@dirrm share/gromacs/template -@dirrm share/gromacs/html/online -@dirrm share/gromacs/html/images -@dirrm share/gromacs/html -@dirrm share/gromacs +include/gromacs/types/symtab.h +include/gromacs/types/topology.h +include/gromacs/types/trx.h +include/gromacs/update.h +include/gromacs/utils.h +include/gromacs/vcm.h +include/gromacs/vec.h +include/gromacs/viewit.h +include/gromacs/wgms.h +include/gromacs/wman.h +include/gromacs/writeps.h +include/gromacs/x86_3dnow.h +include/gromacs/x86_sse.h +include/gromacs/x86_sse2.h +include/gromacs/xdrf.h +include/gromacs/xtcio.h +include/gromacs/xvgr.h +lib/libgmx%%SUFFIX_MPI%%%%SUFFIX_D%%.a +lib/libgmx%%SUFFIX_MPI%%%%SUFFIX_D%%.so +lib/libgmx%%SUFFIX_MPI%%%%SUFFIX_D%%.so.3 +lib/libgmxana%%SUFFIX_D%%.a +lib/libgmxana%%SUFFIX_D%%.so +%%WITHOUT_MPI%%lib/libgmxana%%SUFFIX_D%%.so.3 +%%WITH_MPI%%lib/libgmxana%%SUFFIX_MPI%%%%SUFFIX_D%%.a +%%WITH_MPI%%lib/libgmxana%%SUFFIX_MPI%%%%SUFFIX_D%%.so +%%WITH_MPI%%lib/libgmxana%%SUFFIX_MPI%%%%SUFFIX_D%%.so.3 +lib/libmd%%SUFFIX_MPI%%%%SUFFIX_D%%.a +lib/libmd%%SUFFIX_MPI%%%%SUFFIX_D%%.so +lib/libmd%%SUFFIX_MPI%%%%SUFFIX_D%%.so.3 +%%DATADIR%%/html/gmxfaq.html +%%DATADIR%%/html/images/1ctf-0.2.jpg +%%DATADIR%%/html/images/1ctf-0.5.jpg +%%DATADIR%%/html/images/1ctf-0.jpg +%%DATADIR%%/html/images/1ctf-1.jpg +%%DATADIR%%/html/images/1ctf-10.jpg +%%DATADIR%%/html/images/1ctf-4.jpg +%%DATADIR%%/html/images/articles.gif +%%DATADIR%%/html/images/bench.gif +%%DATADIR%%/html/images/charts_down.gif +%%DATADIR%%/html/images/charts_up.gif +%%DATADIR%%/html/images/faq.gif +%%DATADIR%%/html/images/features.gif +%%DATADIR%%/html/images/flow_down.gif +%%DATADIR%%/html/images/flow_downleft.gif +%%DATADIR%%/html/images/flow_hline.gif +%%DATADIR%%/html/images/flow_left.gif +%%DATADIR%%/html/images/flow_leftright.gif +%%DATADIR%%/html/images/flow_leftrightdown.gif +%%DATADIR%%/html/images/flow_leftrightup.gif +%%DATADIR%%/html/images/flow_leftup.gif +%%DATADIR%%/html/images/flow_right+left.gif +%%DATADIR%%/html/images/flow_right.gif +%%DATADIR%%/html/images/flow_rightleftdown.gif +%%DATADIR%%/html/images/flow_uprightleft.gif +%%DATADIR%%/html/images/flow_vline.gif +%%DATADIR%%/html/images/flow_vrule.gif +%%DATADIR%%/html/images/gmxlogo_small.jpg +%%DATADIR%%/html/images/links.gif +%%DATADIR%%/html/images/mail.gif +%%DATADIR%%/html/images/manual.gif +%%DATADIR%%/html/images/plotje.gif +%%DATADIR%%/html/images/software.gif +%%DATADIR%%/html/images/topologies.gif +%%DATADIR%%/html/images/xvgr.gif +%%DATADIR%%/html/online.html +%%DATADIR%%/html/online/dat.html +%%DATADIR%%/html/online/dlg.html +%%DATADIR%%/html/online/do_dssp.html +%%DATADIR%%/html/online/edi.html +%%DATADIR%%/html/online/editconf.html +%%DATADIR%%/html/online/edo.html +%%DATADIR%%/html/online/edr.html +%%DATADIR%%/html/online/ene.html +%%DATADIR%%/html/online/eneconv.html +%%DATADIR%%/html/online/eps.html +%%DATADIR%%/html/online/files.html +%%DATADIR%%/html/online/flow.html +%%DATADIR%%/html/online/g87.html +%%DATADIR%%/html/online/g96.html +%%DATADIR%%/html/online/g_anaeig.html +%%DATADIR%%/html/online/g_analyze.html +%%DATADIR%%/html/online/g_angle.html +%%DATADIR%%/html/online/g_bond.html +%%DATADIR%%/html/online/g_bundle.html +%%DATADIR%%/html/online/g_chi.html +%%DATADIR%%/html/online/g_cluster.html +%%DATADIR%%/html/online/g_confrms.html +%%DATADIR%%/html/online/g_covar.html +%%DATADIR%%/html/online/g_density.html +%%DATADIR%%/html/online/g_dielectric.html +%%DATADIR%%/html/online/g_dih.html +%%DATADIR%%/html/online/g_dipoles.html +%%DATADIR%%/html/online/g_disre.html +%%DATADIR%%/html/online/g_dist.html +%%DATADIR%%/html/online/g_dyndom.html +%%DATADIR%%/html/online/g_enemat.html +%%DATADIR%%/html/online/g_energy.html +%%DATADIR%%/html/online/g_gyrate.html +%%DATADIR%%/html/online/g_h2order.html +%%DATADIR%%/html/online/g_hbond.html +%%DATADIR%%/html/online/g_helix.html +%%DATADIR%%/html/online/g_lie.html +%%DATADIR%%/html/online/g_mdmat.html +%%DATADIR%%/html/online/g_mindist.html +%%DATADIR%%/html/online/g_morph.html +%%DATADIR%%/html/online/g_msd.html +%%DATADIR%%/html/online/g_nmeig.html +%%DATADIR%%/html/online/g_nmens.html +%%DATADIR%%/html/online/g_order.html +%%DATADIR%%/html/online/g_potential.html +%%DATADIR%%/html/online/g_rama.html +%%DATADIR%%/html/online/g_rdf.html +%%DATADIR%%/html/online/g_rms.html +%%DATADIR%%/html/online/g_rmsdist.html +%%DATADIR%%/html/online/g_rmsf.html +%%DATADIR%%/html/online/g_rotacf.html +%%DATADIR%%/html/online/g_saltbr.html +%%DATADIR%%/html/online/g_sas.html +%%DATADIR%%/html/online/g_sgangle.html +%%DATADIR%%/html/online/g_sorient.html +%%DATADIR%%/html/online/g_tcaf.html +%%DATADIR%%/html/online/g_traj.html +%%DATADIR%%/html/online/g_velacc.html +%%DATADIR%%/html/online/genbox.html +%%DATADIR%%/html/online/genconf.html +%%DATADIR%%/html/online/genion.html +%%DATADIR%%/html/online/genpr.html +%%DATADIR%%/html/online/getting_started.html +%%DATADIR%%/html/online/gmxcheck.html +%%DATADIR%%/html/online/gmxdemo.html +%%DATADIR%%/html/online/gmxdump.html +%%DATADIR%%/html/online/gro.html +%%DATADIR%%/html/online/grompp.html +%%DATADIR%%/html/online/hat.html +%%DATADIR%%/html/online/highway.html +%%DATADIR%%/html/online/include_bot.html +%%DATADIR%%/html/online/include_top.html +%%DATADIR%%/html/online/itp.html +%%DATADIR%%/html/online/log.html +%%DATADIR%%/html/online/m2p.html +%%DATADIR%%/html/online/make_ndx.html +%%DATADIR%%/html/online/map.html +%%DATADIR%%/html/online/mdp.html +%%DATADIR%%/html/online/mdp_opt.html +%%DATADIR%%/html/online/mdrun.html +%%DATADIR%%/html/online/methanol.html +%%DATADIR%%/html/online/mixed.html +%%DATADIR%%/html/online/mk_angndx.html +%%DATADIR%%/html/online/mtx.html +%%DATADIR%%/html/online/ndx.html +%%DATADIR%%/html/online/ngmx.html +%%DATADIR%%/html/online/options.html +%%DATADIR%%/html/online/out.html +%%DATADIR%%/html/online/pdb.html +%%DATADIR%%/html/online/pdb2gmx.html +%%DATADIR%%/html/online/protonate.html +%%DATADIR%%/html/online/protunf.html +%%DATADIR%%/html/online/rtp.html +%%DATADIR%%/html/online/speptide.html +%%DATADIR%%/html/online/style.css +%%DATADIR%%/html/online/tex.html +%%DATADIR%%/html/online/top.html +%%DATADIR%%/html/online/tpa.html +%%DATADIR%%/html/online/tpb.html +%%DATADIR%%/html/online/tpbconv.html +%%DATADIR%%/html/online/tpr.html +%%DATADIR%%/html/online/trj.html +%%DATADIR%%/html/online/trjcat.html +%%DATADIR%%/html/online/trjconv.html +%%DATADIR%%/html/online/trjorder.html +%%DATADIR%%/html/online/trr.html +%%DATADIR%%/html/online/water.html +%%DATADIR%%/html/online/wheel.html +%%DATADIR%%/html/online/x2top.html +%%DATADIR%%/html/online/xpm.html +%%DATADIR%%/html/online/xpm2ps.html +%%DATADIR%%/html/online/xrama.html +%%DATADIR%%/html/online/xtc.html +%%DATADIR%%/html/online/xvg.html +%%DATADIR%%/html/online/yourown.html +%%DATADIR%%/template/Makefile.%%BUILD%%%%SUFFIX_DOUBLE%% +%%DATADIR%%/template/README +%%DATADIR%%/template/template.c +%%DATADIR%%/top/1mlg.itp +%%DATADIR%%/top/2mlg.itp +%%DATADIR%%/top/FF.dat +%%DATADIR%%/top/aminoacids.dat +%%DATADIR%%/top/atom_nom.tbl +%%DATADIR%%/top/atommass.dat +%%DATADIR%%/top/benzamide.itp +%%DATADIR%%/top/bondadd.itp +%%DATADIR%%/top/bonds.dlg +%%DATADIR%%/top/bromacs.dat +%%DATADIR%%/top/buck.itp +%%DATADIR%%/top/ca-shift.dat +%%DATADIR%%/top/cb-shift.dat +%%DATADIR%%/top/co-shift.dat +%%DATADIR%%/top/dec50.gro +%%DATADIR%%/top/decane.itp +%%DATADIR%%/top/dgsolv.dat +%%DATADIR%%/top/dlg.itp +%%DATADIR%%/top/dmso.gro +%%DATADIR%%/top/dmso.itp +%%DATADIR%%/top/edissoc.dat +%%DATADIR%%/top/export.dlg +%%DATADIR%%/top/fa.itp +%%DATADIR%%/top/ffG43a1-c.tdb +%%DATADIR%%/top/ffG43a1-n.tdb +%%DATADIR%%/top/ffG43a1.atp +%%DATADIR%%/top/ffG43a1.ddb +%%DATADIR%%/top/ffG43a1.hdb +%%DATADIR%%/top/ffG43a1.itp +%%DATADIR%%/top/ffG43a1.rtp +%%DATADIR%%/top/ffG43a1bon.itp +%%DATADIR%%/top/ffG43a1nb.itp +%%DATADIR%%/top/ffG43a2-c.tdb +%%DATADIR%%/top/ffG43a2-n.tdb +%%DATADIR%%/top/ffG43a2.atp +%%DATADIR%%/top/ffG43a2.ddb +%%DATADIR%%/top/ffG43a2.hdb +%%DATADIR%%/top/ffG43a2.itp +%%DATADIR%%/top/ffG43a2.rtp +%%DATADIR%%/top/ffG43a2bon.itp +%%DATADIR%%/top/ffG43a2nb.itp +%%DATADIR%%/top/ffG43b1-c.tdb +%%DATADIR%%/top/ffG43b1-n.tdb +%%DATADIR%%/top/ffG43b1.atp +%%DATADIR%%/top/ffG43b1.ddb +%%DATADIR%%/top/ffG43b1.hdb +%%DATADIR%%/top/ffG43b1.itp +%%DATADIR%%/top/ffG43b1.rtp +%%DATADIR%%/top/ffG43b1bon.itp +%%DATADIR%%/top/ffG43b1nb.itp +%%DATADIR%%/top/ff_dum.itp +%%DATADIR%%/top/ffgmx-c.tdb +%%DATADIR%%/top/ffgmx-n.tdb +%%DATADIR%%/top/ffgmx.atp +%%DATADIR%%/top/ffgmx.ddb +%%DATADIR%%/top/ffgmx.hdb +%%DATADIR%%/top/ffgmx.itp +%%DATADIR%%/top/ffgmx.n2t +%%DATADIR%%/top/ffgmx.rtp +%%DATADIR%%/top/ffgmx2-c.tdb +%%DATADIR%%/top/ffgmx2-n.tdb +%%DATADIR%%/top/ffgmx2.atp +%%DATADIR%%/top/ffgmx2.ddb +%%DATADIR%%/top/ffgmx2.hdb +%%DATADIR%%/top/ffgmx2.itp +%%DATADIR%%/top/ffgmx2.rtp +%%DATADIR%%/top/ffgmx2bon.itp +%%DATADIR%%/top/ffgmx2nb.itp +%%DATADIR%%/top/ffgmxbon.itp +%%DATADIR%%/top/ffgmxnb.itp +%%DATADIR%%/top/ffoplsaa-c.tdb +%%DATADIR%%/top/ffoplsaa-n.tdb +%%DATADIR%%/top/ffoplsaa.atp +%%DATADIR%%/top/ffoplsaa.ddb +%%DATADIR%%/top/ffoplsaa.hdb +%%DATADIR%%/top/ffoplsaa.itp +%%DATADIR%%/top/ffoplsaa.rtp +%%DATADIR%%/top/ffoplsaabon.itp +%%DATADIR%%/top/ffoplsaanb.itp +%%DATADIR%%/top/flexspc.itp +%%DATADIR%%/top/flexspce.itp +%%DATADIR%%/top/flexwat-ferguson.itp +%%DATADIR%%/top/gromacs.dtd +%%DATADIR%%/top/gurgle.dat +%%DATADIR%%/top/h2p4o13.itp +%%DATADIR%%/top/h2p8o25.itp +%%DATADIR%%/top/h2po4.itp +%%DATADIR%%/top/ha-shift.dat +%%DATADIR%%/top/ions.itp +%%DATADIR%%/top/links.dat +%%DATADIR%%/top/methanol.itp +%%DATADIR%%/top/phbres.dat +%%DATADIR%%/top/ps.m2p +%%DATADIR%%/top/random.dat +%%DATADIR%%/top/refi_aa.dat +%%DATADIR%%/top/spc.itp +%%DATADIR%%/top/spc216.gro +%%DATADIR%%/top/spce.itp +%%DATADIR%%/top/specbond.dat +%%DATADIR%%/top/ss.map +%%DATADIR%%/top/surface.dat +%%DATADIR%%/top/sw.itp +%%DATADIR%%/top/table6-10.xvg +%%DATADIR%%/top/table6-11.xvg +%%DATADIR%%/top/table6-12.xvg +%%DATADIR%%/top/table6-8.xvg +%%DATADIR%%/top/table6-9.xvg +%%DATADIR%%/top/tfe.itp +%%DATADIR%%/top/tip3p.itp +%%DATADIR%%/top/tip4p.gro +%%DATADIR%%/top/tip4p.itp +%%DATADIR%%/top/tip5p.gro +%%DATADIR%%/top/tip5p.itp +%%DATADIR%%/top/urea+h2o.gro +%%DATADIR%%/top/urea.itp +%%DATADIR%%/top/vdwradii.dat +%%DATADIR%%/top/xlateat.dat +%%DATADIR%%/tutor/cleanit +%%DATADIR%%/tutor/gmxdemo/cpeptide.pdb +%%DATADIR%%/tutor/gmxdemo/demo +%%DATADIR%%/tutor/methanol/conf.gro +%%DATADIR%%/tutor/methanol/grompp.mdp +%%DATADIR%%/tutor/methanol/index.ndx +%%DATADIR%%/tutor/methanol/methanol.itp +%%DATADIR%%/tutor/methanol/methanol.pdb +%%DATADIR%%/tutor/methanol/topol.top +%%DATADIR%%/tutor/mixed/conf.gro +%%DATADIR%%/tutor/mixed/grompp.mdp +%%DATADIR%%/tutor/mixed/index.ndx +%%DATADIR%%/tutor/mixed/mixed.pdb +%%DATADIR%%/tutor/mixed/topol.top +%%DATADIR%%/tutor/nmr1/conf.gro +%%DATADIR%%/tutor/nmr1/grompp.mdp +%%DATADIR%%/tutor/nmr1/pep.pdb +%%DATADIR%%/tutor/nmr1/topol.top +%%DATADIR%%/tutor/nmr2/conf.gro +%%DATADIR%%/tutor/nmr2/genconf.gcp +%%DATADIR%%/tutor/nmr2/grompp.mdp +%%DATADIR%%/tutor/nmr2/pep.pdb +%%DATADIR%%/tutor/nmr2/topol.top +%%DATADIR%%/tutor/speptide/em.mdp +%%DATADIR%%/tutor/speptide/full.mdp +%%DATADIR%%/tutor/speptide/pr.mdp +%%DATADIR%%/tutor/speptide/speptide.pdb +%%DATADIR%%/tutor/water/conf.gro +%%DATADIR%%/tutor/water/grompp.mdp +%%DATADIR%%/tutor/water/index.ndx +%%DATADIR%%/tutor/water/spc216.pdb +%%DATADIR%%/tutor/water/topol.top +@dirrm %%DATADIR%%/tutor/water +@dirrm %%DATADIR%%/tutor/speptide +@dirrm %%DATADIR%%/tutor/nmr2 +@dirrm %%DATADIR%%/tutor/nmr1 +@dirrm %%DATADIR%%/tutor/mixed +@dirrm %%DATADIR%%/tutor/methanol +@dirrm %%DATADIR%%/tutor/gmxdemo +@dirrm %%DATADIR%%/tutor +@dirrm %%DATADIR%%/top +@dirrm %%DATADIR%%/template +@dirrm %%DATADIR%%/html/online +@dirrm %%DATADIR%%/html/images +@dirrm %%DATADIR%%/html +@dirrm %%DATADIR%% @dirrm include/gromacs/types @dirrm include/gromacs |