From: Kevin Boyd Date: Mon, 21 May 2018 01:25:28 +0000 (-0400) Subject: Cosmetic documentation changes X-Git-Url: http://biod.pnpi.spb.ru/gitweb/?a=commitdiff_plain;h=71e5ee3953f0041a9a25dbcedc58d6c9723ec560;p=alexxy%2Fgromacs.git Cosmetic documentation changes Fixed some broken links Spelling errors/tense errors/grammar Change-Id: Ie83e36a46cda2f686098e4e88f0acf13faf2e5cd --- diff --git a/docs/install-guide/index.rst b/docs/install-guide/index.rst index 66833b2179..b39086c7ab 100644 --- a/docs/install-guide/index.rst +++ b/docs/install-guide/index.rst @@ -21,7 +21,7 @@ Quick and dirty installation 1. Get the latest version of your C and C++ compilers. 2. Check that you have CMake version |CMAKE_MINIMUM_REQUIRED_VERSION| or later. 3. Get and unpack the latest version of the |Gromacs| tarball. -4. Make a separate build directory and change to it. +4. Make a separate build directory and change to it. 5. Run ``cmake`` with the path to the source as an argument 6. Run ``make``, ``make check``, and ``make install`` 7. Source ``GMXRC`` to get access to |Gromacs| @@ -80,7 +80,7 @@ appropriate value instead of ``xxx`` : * ``-DCMAKE_PREFIX_PATH=xxx`` to add a non-standard location for CMake to `search for libraries, headers or programs`_ * ``-DCMAKE_INSTALL_PREFIX=xxx`` to install |Gromacs| to a `non-standard location`_ (default ``/usr/local/gromacs``) * ``-DBUILD_SHARED_LIBS=off`` to turn off the building of shared libraries to help with `static linking`_ -* ``-DGMX_FFT_LIBRARY=xxx`` to select whether to use ``fftw``, ``mkl`` or ``fftpack`` libraries for `FFT support`_ +* ``-DGMX_FFT_LIBRARY=xxx`` to select whether to use ``fftw3``, ``mkl`` or ``fftpack`` libraries for `FFT support`_ * ``-DCMAKE_BUILD_TYPE=Debug`` to build |Gromacs| in debug mode Building older versions @@ -256,7 +256,7 @@ Many simulations in |Gromacs| make extensive use of fast Fourier transforms, and a software library to perform these is always required. We recommend FFTW_ (version 3 or higher only) or Intel MKL_. The choice of library can be set with ``cmake --DGMX_FFT_LIBRARY=``, where ```` is one of ``fftw``, +-DGMX_FFT_LIBRARY=``, where ```` is one of ``fftw3``, ``mkl``, or ``fftpack``. FFTPACK is bundled with |Gromacs| as a fallback, and is acceptable if simulation performance is not a priority. When choosing MKL, |Gromacs| will also use MKL for BLAS and @@ -344,12 +344,12 @@ Other optional build components source already. * zlib is used by TNG for compressing some kinds of trajectory data * Building the |Gromacs| documentation is optional, and requires - ImageMagick, pdflatex, bibtex, doxygen, python 2.7, sphinx + ImageMagick, pdflatex, bibtex, doxygen, python 2.7, sphinx |EXPECTED_SPHINX_VERSION|, and pygments. * The |Gromacs| utility programs often write data files in formats suitable for the Grace plotting tool, but it is straightforward to use these files in other plotting programs, too. - + Doing a build of |Gromacs| -------------------------- @@ -645,7 +645,7 @@ However, to reduce build time and binary size we do not generate code for every single possible architecture, which in rare cases (say, Tegra systems) can result in the default build not being able to use some GPUs. If this happens, or if you want to remove some architectures to reduce -binary size and build time, you can alter the target CUDA architectures. +binary size and build time, you can alter the target CUDA architectures. This can be done either with the ``GMX_CUDA_TARGET_SM`` or ``GMX_CUDA_TARGET_COMPUTE`` CMake variables, which take a semicolon delimited string with the two digit suffixes of CUDA (virtual) architectures names, for @@ -926,7 +926,7 @@ from your shell: It will detect what kind of shell you are running and set up your environment for using |Gromacs|. You may wish to arrange for your login scripts to do this automatically; please search the web for -instructions on how to do this for your shell. +instructions on how to do this for your shell. Many of the |Gromacs| programs rely on data installed in the ``share/gromacs`` subdirectory of the installation directory. By diff --git a/docs/user-guide/cutoff-schemes.rst b/docs/user-guide/cutoff-schemes.rst index e78c35d251..6838436345 100644 --- a/docs/user-guide/cutoff-schemes.rst +++ b/docs/user-guide/cutoff-schemes.rst @@ -123,7 +123,7 @@ How to use the Verlet scheme ---------------------------- The Verlet scheme is enabled by default with option :mdp:`cutoff-scheme`. -The value of [.mdp] option :mdp:`verlet-buffer-tolerance` will add a +The value of :ref:`mdp` option :mdp:`verlet-buffer-tolerance` will add a pair-list buffer whose size is tuned for the given energy drift (in kJ/mol/ns per particle). The effective drift is usually much lower, as :ref:`gmx grompp` assumes constant particle velocities. (Note that in single @@ -142,7 +142,7 @@ to -1 and a buffer set manually by specifying :mdp:`rlist` greater than the larger of :mdp:`rcoulomb` and :mdp:`rvdw`. The simplest way to get a reasonable buffer size is to use an NVT mdp file with the target temperature set to what you expect in your NVE simulation, and -transfer the buffer size printed by :ref:`gmx grompp` to your NVE [.mdp] file. +transfer the buffer size printed by :ref:`gmx grompp` to your NVE :ref:`mdp` file. When a GPU is used, nstlist is automatically increased by :ref:`gmx mdrun`, usually to 20 or more; rlist is increased along to stay below the diff --git a/docs/user-guide/faq.rst b/docs/user-guide/faq.rst index 396c046d8f..352681430a 100644 --- a/docs/user-guide/faq.rst +++ b/docs/user-guide/faq.rst @@ -13,7 +13,7 @@ Questions regarding |Gromacs| installation ------------------------------------------ #. Do I need to compile all utilities with MPI? - + With one rarely-used exception (:ref:`pme_error `), only the :ref:`mdrun ` binary is able to use the :ref:`MPI ` parallelism. So you only need to use the ``-DGMX_MPI=on`` flag @@ -33,7 +33,7 @@ Questions concerning system preparation and preprocessing #. Where can I find a solvent :ref:`coordinate file ` for use with :ref:`solvate `? - Suitable equilibrated boxes of solvent :ref:`structure files ` can be found + Suitable equilibrated boxes of solvent :ref:`structure files ` can be found in the ``$GMXDIR/share/gromacs/top`` directory. That location will be searched by default by :ref:`solvate `, for example by using ``-cs spc216.gro`` as an argument. Other solvent boxes can be prepared by the user as described @@ -77,7 +77,7 @@ Questions concerning system preparation and preprocessing You don't need to prepare additional files if you already have all :ref:`itp` and :ref:`top` files prepared through other tools. - Examples for those are `CHARMM-GUI `__, `ATB (Automated Topology Builder `__, + Examples for those are `CHARMM-GUI `__, `ATB (Automated Topology Builder) `__, `pmx `__. and `PRODRG `__. #. How can I build in missing atoms? @@ -128,9 +128,9 @@ Questions regarding simulation methodology #. How do I extend a completed a simulation to longer times? - Please see the section on `managing long simulations`. + Please see the section on :ref:`managing long simulations`. You can either prepare a new :ref:`mdp` file, or extend the simulation time - in the original :ref:`tpr` file using :ref:`convert-tpr``. + in the original :ref:`tpr` file using :ref:`convert-tpr `. .. TODO #. How do I complete a crashed simulation? @@ -156,7 +156,7 @@ Parameterization and Force Fields Parameters for these exotic species aren't available in force field X. What should I do? - First, you should consider on how well :ref:`MD ` will actually describe your + First, you should consider how well :ref:`MD ` will actually describe your system (e.g. see some of the `recent literature `__). Many species are infeasible to model without either atomic polarizability, or QM treatments. Then you need to prepare your own set of parameters and add a new residue @@ -170,7 +170,7 @@ Parameterization and Force Fields **NO**. Molecules parametrized for a given :ref:`force field ` will not behave in a physical manner when interacting with other molecules that have been parametrized according to different standards. If your - required molecule is not included in the force field you need to use, you will + required molecule is not included in the force field you need to use, you will have to parametrize it yourself according to the methodology of this force field. Analysis and Visualization @@ -183,7 +183,7 @@ Analysis and Visualization #. Why am I seeing bonds being created when I watch the trajectory? - Most visualization software determines the bond status of atoms depending + Most visualization softwares determine the bond status of atoms depending on a set of predefined distances. So the bonding pattern created by them might not be the one defined in your :ref:`topology ` file. What matters is the information encoded in there. If the software has read @@ -201,5 +201,3 @@ Analysis and Visualization As the simulation time is calculated using :ref:`floating point arithmetic `, rounding errors can occur but are not of concern. - - diff --git a/docs/user-guide/force-fields.rst b/docs/user-guide/force-fields.rst index 9f940fb646..334fd1f1b9 100644 --- a/docs/user-guide/force-fields.rst +++ b/docs/user-guide/force-fields.rst @@ -53,7 +53,7 @@ Older GROMACS versions need a separate installation of the ffamber ports: CHARMM ^^^^^^ -`CHARMM`_ (Chemistry at HARvard Macromolecular Mechanics) is a both a set of force fields and +`CHARMM`_ (Chemistry at HARvard Macromolecular Mechanics) is a both a set of force fields and a software package for :ref:`molecular dynamics ` simulations and analysis. Includes united atom (CHARMM19) and all atom (CHARMM22, CHARMM27, CHARMM36) :ref:`force fields `. The CHARMM27 force field has been ported to GROMACS and is officially supported as of version 4.5. CHARMM36 force field files can be @@ -97,8 +97,8 @@ nucleotides, sugars etc. and can be applied to chemical and physical systems ran glasses and liquid crystals, to polymers and crystals and solutions of biomolecules. |Gromacs| supports the GROMOS force fields, with all parameters provided in the distribution -for 43a1, 43a2, 45a3, 53a5, 53a6 and 54a7. The GROMOS force fields are `united atom force fields `, -i.e. without explicit aliphatic (non-polar) hydrogens. +for 43a1, 43a2, 45a3, 53a5, 53a6 and 54a7. The GROMOS force fields are +:ref:`united atom force fields `, i.e. without explicit aliphatic (non-polar) hydrogens. * GROMOS 53a6 - in GROMACS format (J. Comput. Chem. 2004 vol. 25 (13): 1656-1676). * GROMOS 53a5 - in GROMACS format (J. Comput. Chem. 2004 vol. 25 (13): 1656-1676). @@ -123,7 +123,7 @@ being `OPLS-AA/M `__. The standard implementations for those force fields are the *BOSS* and *MCPRO* programs developed by the `Jorgensen group `__ -As there is no central web-page to point to, the user is advised to consult the +As there is no central web-page to point to, the user is advised to consult the original literature for the `united atom (OPLS-UA) `__ and `all atom (OPLS-AA) `__ force fields, as well as the Jorgensen group `page `__ diff --git a/docs/user-guide/managing-simulations.rst b/docs/user-guide/managing-simulations.rst index 6cbcbfc3b0..a955349368 100644 --- a/docs/user-guide/managing-simulations.rst +++ b/docs/user-guide/managing-simulations.rst @@ -85,7 +85,7 @@ You should arrange to back up your simulation files frequently. Network file systems on clusters can be configured in more or less conservative ways, and this can lead :ref:`gmx mdrun` to be told that a checkpoint file has been written to disk when actually it is still in memory -somewhere and vulnerable to a power failure or disk that fills or +somewhere and vulnerable to a power failure or disk that fills or fails in the meantime. The UNIX tool rsync can be a useful way to periodically copy your simulation output to a remote storage location, which works safely even while the simulation is underway. Keeping a copy @@ -106,7 +106,7 @@ be extended, use the :ref:`gmx convert-tpr` tool to extend the run, e.g. The time can also be extended using the ``-until`` and ``-nsteps`` options. Note that the original :ref:`mdp` file may have generated velocities, but that is a one-time operation within :ref:`gmx grompp` -that is never performed again by any other tool. +that is never performed again by any other tool. Changing mdp options for a restart ---------------------------------- @@ -193,7 +193,7 @@ The following factors affect the reproducibility of a simulation, and thus its o The important question is whether it is a problem if simulations are not completely reproducible. The answer is yes and no. Reproducibility is a cornerstone of science in general, and hence it is important. -The `Central Limit Theorem ` +The `Central Limit Theorem `_ tells us that in the case of infinitely long simulations, all observables converge to their equilibrium values. Molecular simulations in |Gromacs| adhere to this theorem, and diff --git a/docs/user-guide/mdp-options.rst b/docs/user-guide/mdp-options.rst index 6e568d29e4..19d5b944ab 100644 --- a/docs/user-guide/mdp-options.rst +++ b/docs/user-guide/mdp-options.rst @@ -1596,7 +1596,7 @@ applicable pulling coordinate. .. mdp-value:: no only print the distance for each pull coordinate - + .. mdp-value:: yes print the distance and Cartesian components selected in @@ -2941,7 +2941,7 @@ Non-equilibrium MD Groups that are to be frozen (*i.e.* their X, Y, and/or Z position will not be updated; *e.g.* ``Lipid SOL``). :mdp:`freezedim` specifies for which dimension the freezing applies. To avoid - spurious contibrutions to the virial and pressure due to large + spurious contributions to the virial and pressure due to large forces between completely frozen atoms you need to use energy group exclusions, this also saves computing time. Note that coordinates of frozen atoms are not scaled by pressure-coupling algorithms. @@ -2992,7 +2992,7 @@ Electric fields E(t) = E0 exp ( -(t-t0)^2/(2 sigma^2) ) cos(omega (t-t0)) For example, the four parameters for direction x are set in the - three fields of :mdp:`electric-field-x` (and similar for y and z) + three fields of :mdp:`electric-field-x` (and similar for y and z) like electric-field-x = E0 omega t0 sigma diff --git a/docs/user-guide/mdrun-features.rst b/docs/user-guide/mdrun-features.rst index d21eb827ab..b829e3fbae 100644 --- a/docs/user-guide/mdrun-features.rst +++ b/docs/user-guide/mdrun-features.rst @@ -110,9 +110,9 @@ Controlling the length of the simulation ---------------------------------------- Normally, the length of an MD simulation is best managed through the -[.mdp] option [nsteps](#nsteps), however there are situations where -more control is useful. `gmx mdrun -nsteps 100` overrides the [.mdp] file -and executes 100 steps. `gmx mdrun -maxh 2.5` will terminate the +:ref:`mdp` option :mdp:`nsteps`, however there are situations where +more control is useful. :samp:`gmx mdrun -nsteps 100` overrides the :ref:`mdp` +file and executes 100 steps. :samp:`gmx mdrun -maxh 2.5` will terminate the simulation shortly before 2.5 hours elapse, which can be useful when running under cluster queues (as long as the queuing system does not ever suspend the simulation). @@ -121,12 +121,12 @@ Running a membrane protein embedding simulation ----------------------------------------------- This is a module to help embed a membrane protein into an equilibrated -lipid bilayer at a position and orientation specified by the user. +lipid bilayer at a position and orientation specified by the user. -This method was initially described as a ProtSqueeze technique -(`Yesylevskyy S.O., J Chem Inf Model 47(5) (2007) 1986-94`_) and -later implemented in |Gromacs| as g_membed tool (`Wolf et al, J Comp Chem 31 (2010) 2169-2174`_). -Currently the functionality of g_membed is available in mdrun if +This method was initially described as a ProtSqueeze technique +(`Yesylevskyy S.O., J Chem Inf Model 47(5) (2007) 1986-94`_) and +later implemented in |Gromacs| as g_membed tool (`Wolf et al, J Comp Chem 31 (2010) 2169-2174`_). +Currently the functionality of g_membed is available in mdrun if ``-membed`` option is specified (see below). .. _Yesylevskyy S.O., J Chem Inf Model 47(5) (2007) 1986-94: https://dx.doi.org/10.1021/ci600553y diff --git a/docs/user-guide/mdrun-performance.rst b/docs/user-guide/mdrun-performance.rst index 7e0a873408..3f99da93e5 100644 --- a/docs/user-guide/mdrun-performance.rst +++ b/docs/user-guide/mdrun-performance.rst @@ -427,8 +427,8 @@ cases. ``-gcom`` During the simulation :ref:`gmx mdrun` must communicate between all ranks to compute quantities such as kinetic energy. By default, this - happens whenever plausible, and is influenced by a lot of :ref:`[.mdp] - options. ` The period between communication phases + happens whenever plausible, and is influenced by a lot of + :ref:`mdp options. ` The period between communication phases must be a multiple of :mdp:`nstlist`, and defaults to the minimum of :mdp:`nstcalcenergy` and :mdp:`nstlist`. ``mdrun -gcom`` sets the number of steps that must elapse between diff --git a/docs/user-guide/run-time-errors.rst b/docs/user-guide/run-time-errors.rst index bb58274c88..6cb7fc82ff 100644 --- a/docs/user-guide/run-time-errors.rst +++ b/docs/user-guide/run-time-errors.rst @@ -24,21 +24,21 @@ Possible solutions are: * reduce the scope of the number of atoms selected for analysis. * reduce the length of trajectory file being processed. -* in some cases confusion between Ångström and nm may lead to users wanting to generate a +* in some cases confusion between Ångström and nm may lead to users generating a :ref:`pdb2gmx ` water box that is |10to3| times larger than what they think it is (e.g. :ref:`gmx solvate`). * use a computer with more memory. * install more memory in the computer. .. |10to3| replace:: 10\ :sup:`3` -The user should bear in mind that the cost in time and/or memory for various activities will +The user should bear in mind that the cost in time and/or memory for various activities will scale with the number of atoms/groups/residues *N* or the simulation length *T* as order N, NlogN, or |Nsquared| (or maybe worse!) and the same for *T*, depending on the type of activity. If it takes a long time, have a think about what you are doing, and the underlying algorithm (see the `Reference manual`_, man page, or use the -h flag for the utility), and see if there's something sensible you can do that has better scaling properties. -.. _Reference manual: `gmx-manual-parent-dir`_ +.. _Reference manual: `gmx-manual-parent-dir`_ .. |Nsquared| replace:: N\ :sup:`2` .. _pdb2gmx-errors: @@ -103,7 +103,7 @@ Chain identifier 'X' was used in two non-sequential blocks This means that within the :ref:`coordinate file` fed to :ref:`pdb2gmx`, the X chain has been split, possibly by the incorrect insertion of one molecule within another. The solution is simple: move the inserted molecule to a location within the file so that it is not splitting another molecule. -This message may also mean that the same chain identifier has been used for two +This message may also mean that the same chain identifier has been used for two separate chains. In that case, rename the second chain to a unique identifier. .. _gmx-atom-missing: @@ -111,8 +111,8 @@ separate chains. In that case, rename the second chain to a unique identifier. WARNING: atom X is missing in residue XXX Y in the pdb file ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ -Related to the long bonds/missing atoms error above, this error is usually quite -obvious in its meaning. That is, :ref:`pdb2gmx` expects certain atoms within +Related to the long bonds/missing atoms error above, this error is usually quite +obvious in its meaning. That is, :ref:`pdb2gmx` expects certain atoms within the given residue, based on the entries in the force field :ref:`rtp` file. There are several cases to which this error applies: @@ -121,7 +121,7 @@ There are several cases to which this error applies: what is expected by the :ref:`rtp` entry. In this case, use ``-ignh`` to allow :ref:`pdb2gmx` to add the correct hydrogens for you, or re-name the problematic atoms. -* A terminal residue (usually the N-terminus) is missing H atoms; this usually suggests +* A terminal residue (usually the N-terminus) is missing H atoms; this usually suggests that the proper ``-ter`` option has not been supplied or chosen properly. In the case of the :ref:`AMBER force fields`, nomenclature is typically the problem. N-terminal and C-terminal residues must be prefixed by N and C, respectively. @@ -135,7 +135,7 @@ There are several cases to which this error applies: Contrary to what the error message says, the use of the option ``-missing`` is almost always inappropriate. The ``-missing`` option should only be used to -generate specialized topologies for amino acid-like molecules to take +generate specialized topologies for amino acid-like molecules to take advantage of :ref:`rtp` entries. If you find yourself using ``-missing`` in order to generate a topology for a protein or nucleic acid, don't; the topology produced is likely physically unrealistic. @@ -148,9 +148,9 @@ are expected to match those found in the :ref:`rtp` file that define the buildin block(s) in your structure. In most cases, the problem arises from a naming mismatch, so simply re-name the atoms in your :ref:`coordinate file ` appropriately. In other cases, you may be supplying a structure that has residues that do not conform -to the expectations of the `force field `, in which case you should +to the expectations of the :ref:`force field `, in which case you should investigate why such a difference is occurring and make a decision based on what you -find - use a different `force field `, manually edit the structure, etc. +find - use a different :ref:`force field `, manually edit the structure, etc. No force fields found (files with name 'forcefield.itp' in subdirectories ending on '.ff') ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ @@ -165,7 +165,7 @@ or re-install |Gromacs| before doing so. Errors in :ref:`grompp ` ------------------------------------ -Found a second defaults directive file +Found a second defaults directive file ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ This is caused by the ``[defaults]`` directive appearing more than once in the :ref:`topology ` or @@ -250,7 +250,7 @@ RIGHT:: Further, the atom index of each ``[position_restraint]`` must be relative to the ``[moleculetype]``, not relative to the system (because the parsing has not reached -``[molecules]`` yet, there is no such concept as "system"). So you cannot use the output +``[molecules]`` yet, there is no such concept as "system"). So you cannot use the output of a tool like :ref:`genrestr ` blindly (as ``genrestr -h`` warns). System has non-zero total charge @@ -270,7 +270,7 @@ If the charge is already close to an integer, then the difference is caused by :ref:`rounding errors ` and not a major problem. Note for PME users: It is possible to use a uniform neutralizing background -charge in PME to compensate for a system with a net background charge. +charge in PME to compensate for a system with a net background charge. This may however, especially for non-homogeneous systems, lead to unwanted artifacts, as shown in `Hub, J. S., de Groot, B. L., Grubmüller, H. & Groenhof, G. Quantifying artifacts in Ewald simulations of inhomogeneous systems with a net charge. @@ -348,7 +348,7 @@ This kind of error looks like:: [ file spc.itp, line 32 ] Atom index (1) in bonds out of bounds (1-0). This probably means that you have inserted topology - section "settles" in a part belonging to a different + section "settles" in a part belonging to a different molecule than you intended to. in that case move the "settles" section to the right molecule. @@ -373,7 +373,7 @@ of the :ref:`coordinate file `. When running :ref:`grompp program reads through the :ref:`topology `, mapping the supplied parameters to the atoms in the :ref:`coordinate ` file. If there is a mismatch, this error is generated. To remedy the problem, make sure that the contents of your ``[ molecules ]`` directive -matches the exact order of the atoms in the coordinate file. +matches the exact order of the atoms in the coordinate file. In some cases, the error is harmless. For example, when running simulations with the `MARTINI force field `_, the workflow relies on :ref:`grompp ` to apply the @@ -437,7 +437,7 @@ making use of double precision-enabled |Gromacs|. LINCS/SETTLE/SHAKE warnings ^^^^^^^^^^^^^^^^^^^^^^^^^^^ -Sometimes, when running dynamics, :ref:`mdrun ` may suddenly stop (perhaps after writing +Sometimes, when running dynamics, :ref:`mdrun ` may suddenly stop (perhaps after writing several :ref:`pdb` files) after a series of warnings about the constraint algorithms (e.g. LINCS, SETTLE or SHAKE) are written to the :ref:`log` file. These algorithms often used to constrain bond lengths and/or angles. When a system is :ref:`blowing up ` @@ -473,9 +473,9 @@ written to the output files. There are a number of reasons why this may occur: * Your simulation might simply be (very) :ref:`slow `, and since output is buffered, it can take quite some time for output to appear in the respective files. If you are trying to fix some problems and you want to get output as fast as possible, you can set the environment variable ``GMX_LOG_BUFFER`` to 0. -* Something might be going wrong in your simulation, causing e.g. not-a-numbers (NAN) to be - generated (these are the result of e.g. division by zero). Subsequent calculations - with NAN's will generate floating point exceptions which slow everything down by orders of +* Something might be going wrong in your simulation, causing e.g. not-a-numbers (NAN) to be + generated (these are the result of e.g. division by zero). Subsequent calculations + with NAN's will generate floating point exceptions which slow everything down by orders of magnitude. * You might have all ``nst*`` parameters (see your :ref:`mdp` file) set to 0, this will suppress most output. * Your disk might be full. Eventually this will lead to :ref:`mdrun ` crashing, but