Implement user guide
[alexxy/gromacs.git] / docs / user-guide / mdp-options.md
1 # Molecular dynamics parameters (.mdp options)
2
3 ## General information
4
5 Default values are given in parentheses. The first option in the list is always the default option. Units are given in square brackets The difference between a dash and an underscore is ignored.
6
7 A [sample `.mdp` file](online/mdp.html) is available. This should be appropriate to start a normal simulation. Edit it to suit your specific needs and desires.
8
9
10 ### Preprocessing
11
12 include:
13 :    directories to include in your topology. Format: `-I/home/john/mylib -I../otherlib`
14
15 define:
16 :    defines to pass to the preprocessor, default is no defines. You can use any defines to control options in your customized topology files. Options that are already available by default are:  
17      `-DFLEXIBLE` will use flexible water instead of rigid water into your topology, this can be useful for normal mode analysis.  
18      `-DPOSRES` will trigger the inclusion of `posre.itp` into your topology, used for position restraints.
19
20
21 ### Run control
22
23 integrator:
24 :   (Despite the name, this list includes algorithms that are not actually integrators. **steep** and all entries following it are in this category)
25
26     md
27     :   A leap-frog algorithm for integrating Newton's equations of motion.
28
29     md-vv
30     :   A velocity Verlet algorithm for integrating Newton's equations of motion. For constant NVE simulations started from corresponding points in the same trajectory, the trajectories are analytically, but not binary, identical to the **md** leap-frog integrator. The the kinetic energy, which is determined from the whole step velocities and is therefore slightly too high. The advantage of this integrator is more accurate, reversible Nose-Hoover and Parrinello-Rahman coupling integration based on Trotter expansion, as well as (slightly too small) full step velocity output. This all comes at the cost off extra computation, especially with constraints and extra communication in parallel. Note that for nearly all production simulations the **md** integrator is accurate enough. 
31
32     md-vv-avek
33     :   A velocity Verlet algorithm identical to **md-vv**, except that the kinetic energy is determined as the average of the two half step kinetic energies as in the **md** integrator, and this thus more accurate. With Nose-Hoover and/or Parrinello-Rahman coupling this comes with a slight increase in computational cost.
34
35     sd
36     :   An accurate and efficient leap-frog stochastic dynamics integrator. With constraints, coordinates needs to be constrained twice per integration step. Depending on the computational cost of the force calculation, this can take a significant part of the simulation time. The temperature for one or more groups of atoms (**tc-grps**) is set with **ref-t**, the inverse friction constant for each group is set with **tau-t**. The parameter **tcoupl** is ignored. The random generator is initialized with **ld-seed**. When used as a thermostat, an appropriate value for **tau-t** is 2 ps, since this results in a friction that is lower than the internal friction of water, while it is high enough to remove excess heat NOTE: temperature deviations decay twice as fast as with a Berendsen thermostat with the same **tau-t**.
37
38     sd2
39     :   This used to be the default sd integrator, but is now deprecated. Four Gaussian random numbers are required per coordinate per step. With constraints, the temperature will be slightly too high.
40
41     bd
42     :   An Euler integrator for Brownian or position Langevin dynamics, the velocity is the force divided by a friction coefficient (**bd-fric**) plus random thermal noise (**ref-t**). When **bd-fric**`=0`, the friction coefficient for each particle is calculated as mass/**tau-t**, as for the integrator **sd**. The random generator is initialized with **ld-seed**.
43
44     steep
45     :   A steepest descent algorithm for energy minimization. The maximum step size is **emstep**, the tolerance is **emtol**.
46
47     cg
48     :   A conjugate gradient algorithm for energy minimization, the tolerance is **emtol**. CG is more efficient when a steepest descent step is done every once in a while, this is determined by **nstcgsteep**. For a minimization prior to a normal mode analysis, which requires a very high accuracy, GROMACS should be compiled in double precision.
49
50     l-bfgs
51     :   A quasi-Newtonian algorithm for energy minimization according to the low-memory Broyden-Fletcher-Goldfarb-Shanno approach. In practice this seems to converge faster than Conjugate Gradients, but due to the correction steps necessary it is not (yet) parallelized. 
52
53     nm
54     :   Normal mode analysis is performed on the structure in the [.tpr] file. GROMACS should be compiled in double precision.
55
56     tpi
57     :   Test particle insertion. The last molecule in the topology is the test particle. A trajectory must be provided to `mdrun -rerun`. This trajectory should not contain the molecule to be inserted. Insertions are performed **nsteps** times in each frame at random locations and with random orientiations of the molecule. When **nstlist** is larger than one, **nstlist** insertions are performed in a sphere with radius **rtpi** around a the same random location using the same neighborlist (and the same long-range energy when **rvdw** or **rcoulomb**>**rlist**, which is only allowed for single-atom molecules). Since neighborlist construction is expensive, one can perform several extra insertions with the same list almost for free. The random seed is set with **ld-seed**. The temperature for the Boltzmann weighting is set with **ref-t**, this should match the temperature of the simulation of the original trajectory. Dispersion correction is implemented correctly for TPI. All relevant quantities are written to the file specified with `mdrun -tpi`. The distribution of insertion energies is written to the file specified with `mdrun -tpid`. No trajectory or energy file is written. Parallel TPI gives identical results to single-node TPI. For charged molecules, using PME with a fine grid is most accurate and also efficient, since the potential in the system only needs to be calculated once per frame. 
58
59     tpic
60     :   Test particle insertion into a predefined cavity location. The procedure is the same as for **tpi**, except that one coordinate extra is read from the trajectory, which is used as the insertion location. The molecule to be inserted should be centered at 0,0,0. Gromacs does not do this for you, since for different situations a different way of centering might be optimal. Also **rtpi** sets the radius for the sphere around this location. Neighbor searching is done only once per frame, **nstlist** is not used. Parallel **tpic** gives identical results to single-rank **tpic**.
61
62 tinit: (0) [ps]
63 :    starting time for your run (only makes sense for integrators **md**, **sd** and **bd**)
64
65 dt: (0.001) [ps]
66 :    time step for integration (only makes sense for integrators **md**, **sd** and **bd**)
67
68 nsteps: (0)
69 :    maximum number of steps to integrate or minimize, -1 is no maximum
70
71 init-step: (0)
72 :    The starting step. The time at an step i in a run is calculated as: t = **tinit** + **dt** * (**init-step** + i). The free-energy lambda is calculated as: lambda = **init-lambda** + **delta-lambda** * (**init-step** + i). Also non-equilibrium MD parameters can depend on the step number. Thus for exact restarts or redoing part of a run it might be necessary to set **init-step** to the step number of the restart frame. [gmx convert-tpr] does this automatically.
73
74 comm-mode:
75 :    + **Linear**  
76      Remove center of mass translation
77
78      + **Angular**  
79      Remove center of mass translation and rotation around the center of mass 
80
81      + **None**  
82      No restriction on the center of mass motion 
83
84 nstcomm: (100) [steps]
85 :    frequency for center of mass motion removal
86
87 comm-grps:
88 :    group(s) for center of mass motion removal, default is the whole system
89
90
91 ### Langevin dynamics
92
93 bd-fric: (0) [amu ps-1]
94 :    Brownian dynamics friction coefficient. When **bd-fric** =0, the friction coefficient for each particle is calculated as mass/**tau-t**.
95
96 ld-seed: (-1) [integer]
97 :    used to initialize random generator for thermal noise for stochastic and Brownian dynamics. When **ld-seed** is set to -1, a pseudo random seed is used. When running BD or SD on multiple processors, each processor uses a seed equal to **ld-seed** plus the processor number.
98
99
100 ### Energy minimization
101
102 emtol: (10.0) [kJ mol-1 nm-1]
103 :    the minimization is converged when the maximum force is smaller than this value
104
105 emstep: (0.01) [nm]
106 :    initial step-size
107
108 nstcgsteep: (1000) [steps]
109 :    frequency of performing 1 steepest descent step while doing conjugate gradient energy minimization.
110
111 nbfgscorr: (10)
112 :    Number of correction steps to use for L-BFGS minimization. A higher number is (at least theoretically) more accurate, but slower.
113
114
115 ### Shell Molecular Dynamics
116
117 When shells or flexible constraints are present in the system the positions of the shells and the lengths of the flexible constraints are optimized at every
118 time step until either the RMS force on the shells and constraints is less than emtol, or a maximum number of iterations **niter** has been reached
119
120 emtol: (10.0) [kJ mol-1 nm-1]
121 :    the minimization is converged when the maximum force is smaller than this value. For shell MD this value should be 1.0 at most, but since the variable is used for energy minimization as well the default is 10.0.
122
123 niter: (20)
124 :    maximum number of iterations for optimizing the shell positions and the flexible constraints.
125
126 fcstep: (0) [ps2]
127 :    the step size for optimizing the flexible constraints. Should be chosen as mu/(d2V/dq2) where mu is the reduced mass of two particles in a flexible constraint and d2V/dq2 is the second derivative of the potential in the constraint direction. Hopefully this number does not differ too much between the flexible constraints, as the number of iterations and thus the runtime is very sensitive to **fcstep**. Try several values!
128   
129
130 ### Test particle insertion
131
132 rtpi: (0.05) [nm]
133 :   the test particle insertion radius, see integrators **tpi** and **tpic**
134
135
136 ### Output control
137
138 nstxout: (0) [steps]
139 :    number of steps that elapse between writing coordinates to output trajectory file, the last coordinates are always written
140
141 nstvout: (0) [steps]
142 :    number of steps that elapse between writing velocities to output trajectory, the last velocities are always written
143
144 nstfout: (0) [steps]
145 :    number of steps that elapse between writing forces to output trajectory.
146
147 nstlog: (1000) [steps]
148 :    number of steps that elapse between writing energies to the log file, the last energies are always written
149
150 nstcalcenergy: (100)
151 :    number of steps that elapse between calculating the energies, 0 is never. This option is only relevant with dynamics. With a twin-range cut-off setup **nstcalcenergy** should be equal to or a multiple of **nstlist**. This option affects the performance in parallel simulations, because calculating energies requires global communication between all processes which can become a bottleneck at high parallelization. 
152
153 nstenergy: (1000) [steps]
154 :    number of steps that else between writing energies to energy file, the last energies are always written, should be a multiple of **nstcalcenergy**. Note that the exact sums and fluctuations over all MD steps modulo **nstcalcenergy** are stored in the energy file, so [gmx energy] can report exact energy averages and fluctuations also when **nstenergy** >1
155
156 nstxout-compressed: (0) [steps]
157 :    number of steps that elapse between writing position coordinates using lossy compression
158
159 compressed-x-precision: (1000) [real]
160 :    precision with which to write to the compressed trajectory file
161
162 compressed-x-grps:
163 :    group(s) to write to the compressed trajectory file, by default the whole system is written (if **nstxout-compressed** > 0)
164
165 energygrps:
166 :    group(s) to write to energy file
167   
168
169 ### Neighbor searching
170
171 cutoff-scheme:
172 :   + **Verlet**  
173     Generate a pair list with buffering. The buffer size is automatically set based on **verlet-buffer-tolerance**, unless this is set to -1, in which case **rlist** will be used. This option has an explicit, exact cut-off at **rvdw**=**rcoulomb**. Currently only cut-off, reaction-field, PME electrostatics and plain LJ are supported. Some [mdrun] functionality is not yet supported with the **Verlet** scheme, but [gmx grompp] checks for this. Native GPU acceleration is only supported with **Verlet**. With GPU-accelerated PME or with separate PME ranks, [mdrun] will automatically tune the CPU/GPU load balance by scaling **rcoulomb** and the grid spacing. This can be turned off with `mdrun -notunepme`. **Verlet** is faster than **group** when there is no water, or if **group** would use a pair-list buffer to conserve energy.
174
175     + **group**
176     Generate a pair list for groups of atoms. These groups correspond to the charge groups in the topology. This was the only cut-off treatment scheme before version 4.6, and is **deprecated in 5.0**. There is no explicit buffering of the pair list. This enables efficient force calculations for water, but energy is only conserved when a buffer is explicitly added.
177
178 nstlist: (10) [steps]
179 :   + **>0**  
180     Frequency to update the neighbor list (and the long-range forces, when using twin-range cut-offs). When this is 0, the neighbor list is made only once. With energy minimization the neighborlist will be updated for every energy evaluation when **nstlist** >0. With **cutoff-scheme=Verlet** and **verlet-buffer-tolerance** set, **nstlist** is actually a minimum value and [mdrun] might increase it, unless it is set to 1. With parallel simulations and/or non-bonded force calculation on the GPU, a value of 20 or 40 often gives the best performance. With **cutoff-scheme=Group** and non-exact cut-off's, **nstlist** will affect the accuracy of your simulation and it can not be chosen freely. 
181
182     + **0**  
183     The neighbor list is only constructed once and never updated. This is mainly useful for vacuum simulations in which all particles see each other.
184
185     + **<0**  
186     Unused.
187
188 nstcalclr: (-1) [steps]
189 :   Controls the period between calculations of long-range forces when using the group cut-off scheme. 
190
191     + **1**  
192     Calculate the long-range forces every single step. This is useful to have separate neighbor lists with buffers for electrostatics and Van der Waals interactions, and in particular it makes it possible to have the Van der Waals cutoff longer than electrostatics (useful _e.g._ with PME). However, there is no point in having identical long-range cutoffs for both interaction forms and update them every step - then it will be slightly faster to put everything in the short-range list.
193
194     + **>1**  
195     Calculate the long-range forces every **nstcalclr** steps and use a multiple-time-step integrator to combine forces. This can now be done more frequently than **nstlist** since the lists are stored, and it might be a good idea _e.g._ for Van der Waals interactions that vary slower than electrostatics.
196
197     + **-1**  
198     Calculate long-range forces on steps where neighbor searching is performed. While this is the default value, you might want to consider updating the long-range forces more frequently.
199
200     Note that twin-range force evaluation might be enabled automatically by PP-PME load balancing. This is done in order to maintain the chosen Van der Waals interaction radius even if the load balancing is changing the electrostatics cutoff. If the [.mdp] file already specifies twin-range interactions (_e.g._ to evaluate Lennard-Jones interactions with a longer cutoff than the PME electrostatics every 2-3 steps), the load balancing will have also a small effect on Lennard-Jones, since the short-range cutoff (inside which forces are evaluated every step) is changed.
201
202 ns-type:
203 :   + **grid**  
204     Make a grid in the box and only check atoms in neighboring grid cells when constructing a new neighbor list every **nstlist** steps. In large systems grid search is much faster than simple search.
205
206     + **simple**  
207     Check every atom in the box when constructing a new neighbor list every **nstlist** steps (only with **cutoff-scheme=group**).
208
209 pbc:
210 :   + **xyz**  
211     Use periodic boundary conditions in all directions.
212
213     + **no**  
214     Use no periodic boundary conditions, ignore the box. To simulate without cut-offs, set all cut-offs and **nstlist** to 0. For best performance without cut-offs on a single MPI rank, set **nstlist** to zero and `ns-type=simple`.
215
216     + **xy**  
217     Use periodic boundary conditions in x and y directions only. This works only with `ns-type=grid` and can be used in combination with **walls**. Without walls or with only one wall the system size is infinite in the z direction. Therefore pressure coupling or Ewald summation methods can not be used. These disadvantages do not apply when two walls are used.
218
219 periodic-molecules:
220 :   + **no**  
221     molecules are finite, fast molecular PBC can be used
222
223     + **yes**  
224     for systems with molecules that couple to themselves through the periodic boundary conditions, this requires a slower PBC algorithm and molecules are not made whole in the output
225
226 verlet-buffer-tolerance: (0.005) [kJ/mol/ps]
227 :    Useful only with **cutoff-scheme**=**Verlet**. This sets the maximum allowed error for pair interactions per particle caused by the Verlet buffer, which indirectly sets **rlist**. As both **nstlist** and the Verlet buffer size are fixed (for performance reasons), particle pairs not in the pair list can occasionally get within the cut-off distance during **nstlist**-1 nsteps. This causes very small jumps in the energy. In a constant-temperature ensemble, these very small energy jumps can be estimated for a given cut-off and **rlist**. The estimate assumes a homogeneous particle distribution, hence the errors might be slightly underestimated for multi-phase systems. For longer pair-list life-time (**nstlist**-1)*dt the buffer is overestimated, because the interactions between particles are ignored. Combined with cancellation of errors, the actual drift of the total energy is usually one to two orders of magnitude smaller. Note that the generated buffer size takes into account that the GROMACS pair-list setup leads to a reduction in the drift by a factor 10, compared to a simple particle-pair based list. Without dynamics (energy minimization etc.), the buffer is 5% of the cut-off. For NVE simulations the initial temperature is used, unless this is zero, in which case a buffer of 10% is used. For NVE simulations the tolerance usually needs to be lowered to achieve proper energy conservation on the nanosecond time scale. To override the automated buffer setting, use **verlet-buffer-tolerance**=-1 and set **rlist** manually.
228
229 rlist: (1) [nm]
230 :    Cut-off distance for the short-range neighbor list. With **cutoff-scheme**=**Verlet**, this is by default set by the **verlet-buffer-tolerance** option and the value of **rlist** is ignored.
231
232 rlistlong: (-1) [nm]
233 :    Cut-off distance for the long-range neighbor list. This parameter is only relevant for a twin-range cut-off setup with switched potentials. In that case a buffer region is required to account for the size of charge groups. In all other cases this parameter is automatically set to the longest cut-off distance.
234
235
236 ### Electrostatics
237
238 coulombtype:
239 :   + **Cut-off**  
240     Twin range cut-offs with neighborlist cut-off **rlist** and Coulomb cut-off **rcoulomb**, where **rcoulomb**>=**rlist**.
241
242     + **Ewald**  
243     Classical Ewald sum electrostatics. The real-space cut-off **rcoulomb** should be equal to **rlist**. Use _e.g._ **rlist** =0.9, **rcoulomb** =0.9. The highest magnitude of wave vectors used in reciprocal space is controlled by **fourierspacing**. The relative accuracy of direct/reciprocal space is controlled by **ewald-rtol**.  
244     NOTE: Ewald scales as O(N3/2) and is thus extremely slow for large systems. It is included mainly for reference - in most cases PME will perform much better.
245
246     + **PME**  
247     Fast smooth Particle-Mesh Ewald (SPME) electrostatics. Direct space is similar to the Ewald sum, while the reciprocal part is performed with FFTs. Grid dimensions are controlled with **fourierspacing** and the interpolation order with **pme-order**. With a grid spacing of 0.1 nm and cubic interpolation the electrostatic forces have an accuracy of 2-3*10-4. Since the error from the vdw-cutoff is larger than this you might try 0.15 nm. When running in parallel the interpolation parallelizes better than the FFT, so try decreasing grid dimensions while increasing interpolation.
248
249     + **P3M-AD**  
250     Particle-Particle Particle-Mesh algorithm with analytical derivative for for long range electrostatic interactions. The method and code is identical to SPME, except that the influence function is optimized for the grid. This gives a slight increase in accuracy.
251
252     + **Reaction-Field electrostatics**  
253     Reaction field with Coulomb cut-off **rcoulomb**, where **rcoulomb** >= **rlist**. The dielectric constant beyond the cut-off is **epsilon-rf**. The dielectric constant can be set to infinity by setting **epsilon-rf**=0.
254
255     + **Generalized-Reaction-Field**  
256     Generalized reaction field with Coulomb cut-off **rcoulomb**, where **rcoulomb** >= **rlist**. The dielectric constant beyond the cut-off is **epsilon-rf**. The ionic strength is computed from the number of charged (_i.e._ with non zero charge) charge groups. The temperature for the GRF potential is set with **ref-t**.
257
258     + **Reaction-Field-zero**  
259     In GROMACS, normal reaction-field electrostatics with **cutoff-scheme****=group** leads to bad energy conservation. **Reaction-Field-zero** solves this by making the potential zero beyond the cut-off. It can only be used with an infinite dielectric constant (**epsilon-rf=0**), because only for that value the force vanishes at the cut-off. **rlist** should be 0.1 to 0.3 nm larger than **rcoulomb** to accommodate for the size of charge groups and diffusion between neighbor list updates. This, and the fact that table lookups are used instead of analytical functions make **Reaction-Field-zero** computationally more expensive than normal reaction-field.
260
261     + **Reaction-Field-nec**  
262     The same as **Reaction-Field**, but implemented as in GROMACS versions before 3.3. No reaction-field correction is applied to excluded atom pairs and self pairs. The 1-4 interactions are calculated using a reaction-field. The missing correction due to the excluded pairs that do not have a 1-4 interaction is up to a few percent of the total electrostatic energy and causes a minor difference in the forces and the pressure.
263
264     + **Shift**  
265     Analogous to **Shift** for **vdwtype**. You might want to use **Reaction-Field-zero** instead, which has a similar potential shape, but has a physical interpretation and has better energies due to the exclusion correction terms. 
266
267     + **Encad-Shift**  
268     The Coulomb potential is decreased over the whole range, using the definition from the Encad simulation package.
269
270     + **Switch**  
271     Analogous to **Switch** for **vdwtype**. Switching the Coulomb potential can lead to serious artifacts, advice: use **Reaction-Field-zero** instead.
272
273     + **User**  
274     [mdrun] will now expect to find a file `table.xvg` with user-defined potential functions for repulsion, dispersion and Coulomb. When pair interactions are present, [mdrun] also expects to find a file `tablep.xvg` for the pair interactions. When the same interactions should be used for non-bonded and pair interactions the user can specify the same file name for both table files. These files should contain 7 columns: the `x` value, `f(x)`, `-f'(x)`, `g(x)`, `-g'(x)`, `h(x)`, `-h'(x)`, where `f(x)` is the Coulomb function, `g(x)` the dispersion function and `h(x)` the repulsion function. When **vdwtype** is not set to **User** the values for `g`, `-g'`, `h` and `-h'` are ignored. For the non-bonded interactions `x` values should run from 0 to the largest cut-off distance + **table-extension** and should be uniformly spaced. For the pair interactions the table length in the file will be used. The optimal spacing, which is used for non-user tables, is `0.002 nm` when you run in mixed precision or `0.0005 nm` when you run in double precision. The function value at `x=0` is not important. More information is in the printed manual.
275
276     + **PME-Switch**  
277     A combination of PME and a switch function for the direct-space part (see above). **rcoulomb** is allowed to be smaller than **rlist**. This is mainly useful constant energy simulations (note that using **PME** with **cutoff-scheme**=**Verlet** will be more efficient). 
278
279     + **PME-User**  
280     A combination of PME and user tables (see above). **rcoulomb** is allowed to be smaller than **rlist**. The PME mesh contribution is subtracted from the user table by [mdrun]. Because of this subtraction the user tables should contain about 10 decimal places.
281
282     + **PME-User-Switch**  
283     A combination of PME-User and a switching function (see above). The switching function is applied to final particle-particle interaction, _i.e._ both to the user supplied function and the PME Mesh correction part.
284
285 coulomb-modifier:
286 :   + **Potential-shift-Verlet**  
287     Selects **Potential-shift** with the Verlet cutoff-scheme, as it is (nearly) free; selects **None** with the group cutoff-scheme.
288
289     + **Potential-shift**  
290     Shift the Coulomb potential by a constant such that it is zero at the cut-off. This makes the potential the integral of the force. Note that this does not affect the forces or the sampling.
291
292     + **None**  
293     Use an unmodified Coulomb potential. With the group scheme this means no exact cut-off is used, energies and forces are calculated for all pairs in the neighborlist.
294
295 rcoulomb-switch: (0) [nm]
296 :   where to start switching the Coulomb potential, only relevant when force or potential switching is used
297
298 rcoulomb: (1) [nm]
299 :   distance for the Coulomb cut-off
300
301 epsilon-r: (1)
302 :   The relative dielectric constant. A value of 0 means infinity.
303
304 epsilon-rf: (0)
305 :   The relative dielectric constant of the reaction field. This is only used with reaction-field electrostatics. A value of 0 means infinity.
306
307
308 ### VdW
309
310 vdwtype:
311 :   + **Cut-off**    
312     Twin range cut-offs with neighbor list cut-off **rlist** and VdW cut-off **rvdw**, where **rvdw** >= **rlist**.
313
314     + **PME**    
315     Fast smooth Particle-mesh Ewald (SPME) for VdW interactions. The grid dimensions are controlled with **fourierspacing** in the same way as for electrostatics, and the interpolation order is controlled with **pme-order**. The relative accuracy of direct/reciprocal space is controlled by **ewald-rtol-lj**, and the specific combination rules that are to be used by the reciprocal routine are set using **lj-pme-comb-rule**.
316
317     + **Shift**    
318     This functionality is deprecated and replaced by **vdw-modifier = Force-switch**. The LJ (not Buckingham) potential is decreased over the whole range and the forces decay smoothly to zero between **rvdw-switch** and **rvdw**. The neighbor search cut-off **rlist** should be 0.1 to 0.3 nm larger than **rvdw** to accommodate for the size of charge groups and diffusion between neighbor list updates.
319
320     + **Switch**    
321     This functionality is deprecated and replaced by **vdw-modifier = Potential-switch**. The LJ (not Buckingham) potential is normal out to **rvdw-switch**, after which it is switched off to reach zero at **rvdw**. Both the potential and force functions are continuously smooth, but be aware that all switch functions will give rise to a bulge (increase) in the force (since we are switching the potential). The neighbor search cut-off **rlist** should be 0.1 to 0.3 nm larger than **rvdw** to accommodate for the size of charge groups and diffusion between neighbor list updates.
322
323     + **Encad-Shift**    
324     The LJ (not Buckingham) potential is decreased over the whole range, using the definition from the Encad simulation package.
325
326     + **User**    
327     See **user** for **coulombtype**. The function value at zero is not important. When you want to use LJ correction, make sure that **rvdw** corresponds to the cut-off in the user-defined function. When **coulombtype** is not set to **User** the values for `f` and `-f'` are ignored.
328
329 vdw-modifier:
330 :   + **Potential-shift-Verlet**    
331     Selects **Potential-shift** with the Verlet cutoff-scheme, as it is (nearly) free; selects **None** with the group cutoff-scheme.
332
333     + **Potential-shift**    
334     Shift the Van der Waals potential by a constant such that it is zero at the cut-off. This makes the potential the integral of the force. Note that this does not affect the forces or the sampling.
335
336     + **None**    
337     Use an unmodified Van der Waals potential. With the group scheme this means no exact cut-off is used, energies and forces are calculated for all pairs in the neighborlist.
338
339     + **Force-switch**    
340     Smoothly switches the forces to zero between **rvdw-switch** and **rvdw**. This shifts the potential shift over the whole range and switches it to zero at the cut-off. Note that this is more expensive to calculate than a plain cut-off and it is not required for energy conservation, since **Potential-shift** conserves energy just as well.
341
342     + **Potential-switch**    
343     Smoothly switches the potential to zero between **rvdw-switch** and **rvdw**. Note that this introduces articifically large forces in the switching region and is much more expensive to calculate. This option should only be used if the force field you are using requires this.
344
345 rvdw-switch: (0) [nm]
346 :    where to start switching the LJ force and possibly the potential, only relevant when force or potential switching is used
347
348 rvdw: (1) [nm]
349 :    distance for the LJ or Buckingham cut-off
350
351 DispCorr:
352 :   + **no**    
353     don't apply any correction
354
355     + **EnerPres**    
356     apply long range dispersion corrections for Energy and Pressure
357
358     + **Ener**    
359     apply long range dispersion corrections for Energy only
360
361
362 ### Tables
363
364 table-extension: (1) [nm]
365 :    Extension of the non-bonded potential lookup tables beyond the largest cut-off distance. The value should be large enough to account for charge group sizes and the diffusion between neighbor-list updates. Without user defined potential the same table length is used for the lookup tables for the 1-4 interactions, which are always tabulated irrespective of the use of tables for the non-bonded interactions. The value of **table-extension** in no way affects the values of **rlist**, **rcoulomb**, or **rvdw**. 
366
367 energygrp-table:
368 :    When user tables are used for electrostatics and/or VdW, here one can give pairs of energy groups for which seperate user tables should be used. The two energy groups will be appended to the table file name, in order of their definition in **energygrps**, seperated by underscores. For example, if `energygrps = Na Cl Sol` and `energygrp-table = Na Na Na Cl`, [mdrun] will read `table_Na_Na.xvg` and `table_Na_Cl.xvg` in addition to the normal `table.xvg` which will be used for all other energy group pairs. 
369
370
371 ### Ewald
372
373 fourierspacing: (0.12) [nm]
374 :    For ordinary Ewald, the ratio of the box dimensions and the spacing determines a lower bound for the number of wave vectors to use in each (signed) direction. For PME and P3M, that ratio determines a lower bound for the number of Fourier-space grid points that will be used along that axis. In all cases, the number for each direction can be overridden by entering a non-zero value for **fourier_n[xyz]**. For optimizing the relative load of the particle-particle interactions and the mesh part of PME, it is useful to know that the accuracy of the electrostatics remains nearly constant when the Coulomb cut-off and the PME grid spacing are scaled by the same factor.
375
376 fourier-nx (0) ; fourier-ny (0) ; fourier-nz: (0)
377 :    Highest magnitude of wave vectors in reciprocal space when using Ewald.
378     Grid size when using PME or P3M. These values override **fourierspacing** per direction. The best choice is powers of 2, 3, 5 and 7. Avoid large primes.
379
380 pme-order (4)
381 :    Interpolation order for PME. 4 equals cubic interpolation. You might try 6/8/10 when running in parallel and simultaneously decrease grid dimension.
382
383 ewald-rtol (1e-5)
384 :    The relative strength of the Ewald-shifted direct potential at **rcoulomb** is given by **ewald-rtol**. Decreasing this will give a more accurate direct sum, but then you need more wave vectors for the reciprocal sum.
385
386 ewald-rtol-lj (1e-3)
387 :    When doing PME for VdW-interactions, **ewald-rtol-lj** is used to control the relative strength of the dispersion potential at **rvdw** in the same way as **ewald-rtol** controls the electrostatic potential.
388
389 lj-pme-comb-rule (Geometric)
390 :    The combination rules used to combine VdW-parameters in the reciprocal part of LJ-PME. Geometric rules are much faster than Lorentz-Berthelot and usually the recommended choice, even when the rest of the force field uses the Lorentz-Berthelot rules.
391
392     + **Geometric**    
393     Apply geometric combination rules
394
395     + **Lorentz-Berthelot**    
396     Apply Lorentz-Berthelot combination rules
397
398 ewald-geometry: (3d)
399 :   + **3d**    
400     The Ewald sum is performed in all three dimensions.
401
402     + **3dc**    
403     The reciprocal sum is still performed in 3D, but a force and potential correction applied in the `z` dimension to produce a pseudo-2D summation. If your system has a slab geometry in the `x-y` plane you can try to increase the `z`-dimension of the box (a box height of 3 times the slab height is usually ok) and use this option.
404
405 epsilon-surface: (0)
406 :    This controls the dipole correction to the Ewald summation in 3D. The default value of zero means it is turned off. Turn it on by setting it to the value of the relative permittivity of the imaginary surface around your infinite system. Be careful - you shouldn't use this if you have free mobile charges in your system. This value does not affect the slab 3DC variant of the long range corrections.
407
408
409 ### Temperature coupling
410
411 tcoupl:
412 :   + **no**    
413     No temperature coupling.
414
415     + **berendsen**    
416     Temperature coupling with a Berendsen-thermostat to a bath with temperature **ref-t**, with time constant **tau-t**. Several groups can be coupled separately, these are specified in the **tc-grps** field separated by spaces.
417
418     + **nose-hoover**    
419     Temperature coupling using a Nose-Hoover extended ensemble. The reference temperature and coupling groups are selected as above, but in this case **tau-t** controls the period of the temperature fluctuations at equilibrium, which is slightly different from a relaxation time. For NVT simulations the conserved energy quantity is written to energy and log file.
420
421     + **andersen**    
422     Temperature coupling by randomizing a fraction of the particles at each timestep. Reference temperature and coupling groups are selected as above. **tau-t** is the average time between randomization of each molecule. Inhibits particle dynamics somewhat, but little or no ergodicity issues. Currently only implemented with velocity Verlet, and not implemented with constraints.
423
424     + **andersen-massive**    
425     Temperature coupling by randomizing all particles at infrequent timesteps. Reference temperature and coupling groups are selected as above. **tau-t** is the time between randomization of all molecules. Inhibits particle dynamics somewhat, but little or no ergodicity issues. Currently only implemented with velocity Verlet.
426
427     + **v-rescale**    
428     Temperature coupling using velocity rescaling with a stochastic term (JCP 126, 014101). This thermostat is similar to Berendsen coupling, with the same scaling using **tau-t**, but the stochastic term ensures that a proper canonical ensemble is generated. The random seed is set with **ld-seed**. This thermostat works correctly even for **tau-t**=0. For NVT simulations the conserved energy quantity is written to the energy and log file.
429
430 nsttcouple: (-1)
431 :    The frequency for coupling the temperature. The default value of -1 sets **nsttcouple** equal to **nstlist**, unless **nstlist**<=0, then a value of 10 is used. For velocity Verlet integrators **nsttcouple** is set to 1.
432
433 nh-chain-length (10)
434 :    the number of chained Nose-Hoover thermostats for velocity Verlet integrators, the leap-frog **md** integrator only supports 1. Data for the NH chain variables is not printed to the .edr, but can be using the `GMX_NOSEHOOVER_CHAINS` environment variable
435
436 tc-grps:
437 :    groups to couple to separate temperature baths
438
439 tau-t: [ps]
440 :    time constant for coupling (one for each group in **tc-grps**), -1 means no temperature coupling
441
442 ref-t: [K]
443 :    reference temperature for coupling (one for each group in **tc-grps**)
444   
445
446 ### Pressure coupling
447
448 pcoupl:
449 :   + **no**    
450     No pressure coupling. This means a fixed box size.
451
452     + **berendsen**    
453     Exponential relaxation pressure coupling with time constant **tau-p**. The box is scaled every timestep. It has been argued that this does not yield a correct thermodynamic ensemble, but it is the most efficient way to scale a box at the beginning of a run.
454
455     + **Parrinello-Rahman**    
456     Extended-ensemble pressure coupling where the box vectors are subject to an equation of motion. The equation of motion for the atoms is coupled to this. No instantaneous scaling takes place. As for Nose-Hoover temperature coupling the time constant **tau-p** is the period of pressure fluctuations at equilibrium. This is probably a better method when you want to apply pressure scaling during data collection, but beware that you can get very large oscillations if you are starting from a different pressure. For simulations where the exact fluctation of the NPT ensemble are important, or if the pressure coupling time is very short it may not be appropriate, as the previous time step pressure is used in some steps of the GROMACS implementation for the current time step pressure.
457
458     + **MTTK**    
459     Martyna-Tuckerman-Tobias-Klein implementation, only useable with **md-vv** or **md-vv-avek**, very similar to Parrinello-Rahman. As for Nose-Hoover temperature coupling the time constant **tau-p** is the period of pressure fluctuations at equilibrium. This is probably a better method when you want to apply pressure scaling during data collection, but beware that you can get very large oscillations if you are starting from a different pressure. Currently (as of version 5.1), it only supports isotropic scaling, and only works without constraints.
460
461 pcoupltype:
462 :   + **isotropic**    
463     Isotropic pressure coupling with time constant **tau-p**. The compressibility and reference pressure are set with **compressibility** and **ref-p**, one value is needed.
464
465     + **semiisotropic**    
466     Pressure coupling which is isotropic in the `x` and `y` direction, but different in the `z` direction. This can be useful for membrane simulations. 2 values are needed for `x/y` and `z` directions respectively.
467
468     + **anisotropic**    
469     Idem, but 6 values are needed for `xx`, `yy`, `zz`, `xy/yx`, `xz/zx` and `yz/zy` components, respectively. When the off-diagonal compressibilities are set to zero, a rectangular box will stay rectangular. Beware that anisotropic scaling can lead to extreme deformation of the simulation box.
470
471     + **surface-tension**    
472     Surface tension coupling for surfaces parallel to the xy-plane. Uses normal pressure coupling for the `z`-direction, while the surface tension is coupled to the `x/y` dimensions of the box. The first **ref-p** value is the reference surface tension times the number of surfaces [bar nm], the second value is the reference `z`-pressure [bar]. The two **compressibility** values are the compressibility in the `x/y` and `z` direction respectively. The value for the `z`-compressibility should be reasonably accurate since it influences the convergence of the surface-tension, it can also be set to zero to have a box with constant height.
473
474 nstpcouple: (-1)
475 :    The frequency for coupling the pressure. The default value of -1 sets **nstpcouple** equal to **nstlist**, unless **nstlist** <=0, then a value of 10 is used. For velocity Verlet integrators **nstpcouple** is set to 1.
476
477 tau-p: (1) [ps]
478 :    time constant for coupling
479
480 compressibility: [bar-1]
481 :    compressibility (NOTE: this is now really in bar-1) For water at 1 atm and 300 K the compressibility is 4.5e-5 [bar-1].
482
483 ref-p: [bar]
484 :    reference pressure for coupling
485
486 refcoord-scaling:
487 :   + **no**    
488     The reference coordinates for position restraints are not modified. Note that with this option the virial and pressure will depend on the absolute positions of the reference coordinates.
489
490     + **all**    
491     The reference coordinates are scaled with the scaling matrix of the pressure coupling.
492
493     + **com**    
494     Scale the center of mass of the reference coordinates with the scaling matrix of the pressure coupling. The vectors of each reference coordinate to the center of mass are not scaled. Only one COM is used, even when there are multiple molecules with position restraints. For calculating the COM of the reference coordinates in the starting configuration, periodic boundary conditions are not taken into account. 
495
496
497 ### Simulated annealing
498
499 Simulated annealing is controlled separately for each temperature group in GROMACS. The reference temperature is a piecewise linear function, but you can use an arbitrary number of points for each group, and choose either a single sequence or a periodic behaviour for each group. The actual annealing is performed by dynamically changing the reference temperature used in the thermostat algorithm selected, so remember that the system will usually not instantaneously reach the reference temperature!
500
501 annealing:
502 :    Type of annealing for each temperature group
503     
504     + **no**    
505     No simulated annealing - just couple to reference temperature value.
506
507     + **single**    
508     A single sequence of annealing points. If your simulation is longer than the time of the last point, the temperature will be coupled to this constant value after the annealing sequence has reached the last time point.
509
510     + **periodic**    
511     The annealing will start over at the first reference point once the last reference time is reached. This is repeated until the simulation ends. 
512
513 annealing-npoints:
514 :    A list with the number of annealing reference/control points used for each temperature group. Use 0 for groups that are not annealed. The number of entries should equal the number of temperature groups.
515
516 annealing-time:
517 :    List of times at the annealing reference/control points for each group. If you are using periodic annealing, the times will be used modulo the last value, _i.e._ if the values are 0, 5, 10, and 15, the coupling will restart at the 0ps value after 15ps, 30ps, 45ps, etc. The number of entries should equal the sum of the numbers given in **annealing-npoints**.
518
519 annealing-temp:
520 :    List of temperatures at the annealing reference/control points for each group. The number of entries should equal the sum of the numbers given in **annealing-npoints**.
521
522      Confused? OK, let's use an example. Assume you have two temperature groups, set the group selections to `annealing = single periodic`, the number of points of each group to `annealing-npoints = 3 4`, the times to `annealing-time = 0 3 6 0 2 4 6` and finally temperatures to `annealing-temp = 298 280 270 298 320 320 298`. The first group will be coupled to 298K at 0ps, but the reference temperature will drop linearly to reach 280K at 3ps, and then linearly between 280K and 270K from 3ps to 6ps. After this is stays constant, at 270K. The second group is coupled to 298K at 0ps, it increases linearly to 320K at 2ps, where it stays constant until 4ps. Between 4ps and 6ps it decreases to 298K, and then it starts over with the same pattern again, _i.e._ rising linearly from 298K to 320K between 6ps and 8ps. Check the summary printed by [gmx grompp] if you are unsure!  
523
524
525 ### Velocity generation
526
527 gen-vel:
528 :   + **no**    
529      Do not generate velocities. The velocities are set to zero when there are no velocities in the input structure file.
530
531     + **yes**    
532     Generate velocities in [gmx grompp] according to a Maxwell distribution at temperature **gen-temp**, with random seed **gen-seed**. This is only meaningful with integrator **md**.
533
534 gen-temp: (300) [K]
535 :    temperature for Maxwell distribution
536
537 gen-seed: (-1) [integer]
538 :    used to initialize random generator for random velocities, when **gen-seed** is set to -1, a pseudo random seed is used.    
539
540
541 ### Bonds
542
543 constraints:
544 :   + **none**    
545     No constraints except for those defined explicitly in the topology, _i.e._ bonds are represented by a harmonic (or other) potential or a Morse potential (depending on the setting of **morse**) and angles by a harmonic (or other) potential. **h-bonds**
546     Convert the bonds with H-atoms to constraints.
547
548     + **all-bonds**    
549     Convert all bonds to constraints.
550
551     + **h-angles**    
552     Convert all bonds and additionally the angles that involve H-atoms to bond-constraints.
553
554     + **all-angles**    
555     Convert all bonds and angles to bond-constraints.
556
557 constraint-algorithm:
558 :   + **LINCS**    
559     LINear Constraint Solver. With domain decomposition the parallel version P-LINCS is used. The accuracy in set with **lincs-order**, which sets the number of matrices in the expansion for the matrix inversion. After the matrix inversion correction the algorithm does an iterative correction to compensate for lengthening due to rotation. The number of such iterations can be controlled with **lincs-iter**. The root mean square relative constraint deviation is printed to the log file every **nstlog** steps. If a bond rotates more than **lincs-warnangle** in one step, a warning will be printed both to the log file and to `stderr`. LINCS should not be used with coupled angle constraints.
560
561     + **SHAKE**    
562     SHAKE is slightly slower and less stable than LINCS, but does work with angle constraints. The relative tolerance is set with **shake-tol**, 0.0001 is a good value for "normal" MD. SHAKE does not support constraints between atoms on different nodes, thus it can not be used with domain decompositon when inter charge-group constraints are present. SHAKE can not be used with energy minimization.
563
564 continuation:
565 :    This option was formerly known as **unconstrained-start**.
566
567     + **no**    
568     apply constraints to the start configuration and reset shells
569
570     + **yes**    
571     do not apply constraints to the start configuration and do not reset shells, useful for exact coninuation and reruns
572
573 shake-tol: (0.0001)
574 :    relative tolerance for SHAKE
575
576 lincs-order: (4)
577 :    Highest order in the expansion of the constraint coupling matrix. When constraints form triangles, an additional expansion of the same order is applied on top of the normal expansion only for the couplings within such triangles. For "normal" MD simulations an order of 4 usually suffices, 6 is needed for large time-steps with virtual sites or BD. For accurate energy minimization an order of 8 or more might be required. With domain decomposition, the cell size is limited by the distance spanned by **lincs-order**+1 constraints. When one wants to scale further than this limit, one can decrease **lincs-order** and increase **lincs-iter**, since the accuracy does not deteriorate when (1+**lincs-iter**)***lincs-order** remains constant.
578
579 lincs-iter: (1)
580 :    Number of iterations to correct for rotational lengthening in LINCS. For normal runs a single step is sufficient, but for NVE runs where you want to conserve energy accurately or for accurate energy minimization you might want to increase it to 2.
581
582 lincs-warnangle: (30) [degrees]
583 :    maximum angle that a bond can rotate before LINCS will complain
584
585 morse:
586 :   + **no**    
587     bonds are represented by a harmonic potential
588
589     + **yes**    
590     bonds are represented by a Morse potential
591
592
593 ### Energy group exclusions
594
595 energygrp-excl: 
596 :    Pairs of energy groups for which all non-bonded interactions are excluded. An example: if you have two energy groups `Protein` and `SOL`, specifying `energygrp-excl = Protein Protein  SOL SOL` would give only the non-bonded interactions between the protein and the solvent. This is especially useful for speeding up energy calculations with `mdrun -rerun` and for excluding interactions within frozen groups.
597
598
599 ### Walls
600
601 nwall: 0
602 :    When set to **1** there is a wall at `z=0`, when set to **2** there is also a wall at `z=z-box`. Walls can only be used with **pbc=xy**. When set to **2** pressure coupling and Ewald summation can be used (it is usually best to use semiisotropic pressure coupling with the `x/y` compressibility set to 0, as otherwise the surface area will change). Walls interact wit the rest of the system through an optional **wall-atomtype**. Energy groups `wall0` and `wall1` (for **nwall=2**) are added automatically to monitor the interaction of energy groups with each wall. The center of mass motion removal will be turned off in the `z`-direction.
603
604 wall-atomtype:
605 :    the atom type name in the force field for each wall. By (for example) defining a special wall atom type in the topology with its own combination rules, this allows for independent tuning of the interaction of each atomtype with the walls.
606
607 wall-type:
608 :   + **9-3**    
609     LJ integrated over the volume behind the wall: 9-3 potential
610
611     + **10-4**    
612     LJ integrated over the wall surface: 10-4 potential
613
614     + **12-6**    
615     direct LJ potential with the `z` distance from the wall
616
617     + **table**    
618     user defined potentials indexed with the `z` distance from the wall, the tables are read analogously to the **energygrp-table** option, where the first name is for a "normal" energy group and the second name is `wall0` or `wall1`, only the dispersion and repulsion columns are used
619
620 wall-r-linpot: -1 (nm)
621 :    Below this distance from the wall the potential is continued linearly and thus the force is constant. Setting this option to a postive value is especially useful for equilibration when some atoms are beyond a wall. When the value is <=0 (<0 for **wall-type=table**), a fatal error is generated when atoms are beyond a wall. 
622
623 wall-density: [nm-3/nm-2]
624 :    the number density of the atoms for each wall for wall types **9-3** and **10-4** 
625
626 wall-ewald-zfac: 3
627 :    The scaling factor for the third box vector for Ewald summation only, the minimum is 2. Ewald summation can only be used with **nwall=2**, where one should use **ewald-geometry`=3dc`**. The empty layer in the box serves to decrease the unphysical Coulomb interaction between periodic images.
628   
629
630 ### COM pulling
631
632 pull:
633 :   + **no**    
634     No center of mass pulling. All the following pull options will be ignored (and if present in the [.mdp] file, they unfortunately generate warnings)
635
636     + **umbrella**    
637     Center of mass pulling using an umbrella potential between the reference group and one or more groups.
638
639     + **constraint**    
640     Center of mass pulling using a constraint between the reference group and one or more groups. The setup is identical to the option **umbrella**, except for the fact that a rigid constraint is applied instead of a harmonic potential.
641
642     + **constant-force**    
643     Center of mass pulling using a linear potential and therefore a constant force. For this option there is no reference position and therefore the parameters **pull-init** and **pull-rate** are not used.
644
645 pull-geometry:
646 :   + **distance**    
647     Pull along the vector connecting the two groups. Components can be selected with **pull-dim**.
648
649     + **direction**    
650     Pull in the direction of **pull-vec**.
651
652     + **direction-periodic**    
653     As **direction**, but allows the distance to be larger than half the box size. With this geometry the box should not be dynamic (_e.g._ no pressure scaling) in the pull dimensions and the pull force is not added to virial.
654
655     + **cylinder**    
656     Designed for pulling with respect to a layer where the reference COM is given by a local cylindrical part of the reference group. The pulling is in the direction of **pull-vec**. From the reference group a cylinder is selected around the axis going through the pull group with direction **pull-vec** using two radii. The radius **pull-r1** gives the radius within which all the relative weights are one, between **pull-r1** and **pull-r0** the weights are switched to zero. Mass weighting is also used. Note that the radii should be smaller than half the box size. For tilted cylinders they should be even smaller than half the box size since the distance of an atom in the reference group from the COM of the pull group has both a radial and an axial component.
657
658 pull-dim: (Y Y Y)
659 :    the distance components to be used with geometry **distance**, and also sets which components are printed to the output files
660
661 pull-r1: (1) [nm]
662 :    the inner radius of the cylinder for geometry **cylinder**
663
664 pull-r0: (1) [nm]
665 :    the outer radius of the cylinder for geometry **cylinder**
666
667 pull-constr-tol: (1e-6)
668 :    the relative constraint tolerance for constraint pulling
669
670 pull-start:
671 :   + **no**    
672     do not modify **pull-init**
673
674     + **yes**
675     add the COM distance of the starting conformation to **pull-init**
676
677 pull-print-reference: (10)
678 :   + **no**    
679     do not print the COM of the first group in each pull coordinate
680
681     + **yes**    
682     print the COM of the first group in each pull coordinate
683
684 pull-nstxout: (10)
685 :    frequency for writing out the COMs of all the pull group
686
687 pull-nstfout: (1)
688 :    frequency for writing out the force of all the pulled group
689
690 pull-ngroups: (1)
691 :    The number of pull groups, not including the absolute reference group, when used. Pull groups can be reused in multiple pull coordinates. Below only the pull options for group 1 are given, further groups simply increase the group index number.
692
693 pull-ncoords: (1)
694 :    The number of pull coordinates. Below only the pull options for coordinate 1 are given, further coordinates simply increase the coordinate index number.
695
696 pull-group1-name: 
697 :    The name of the pull group, is looked up in the index file or in the default groups to obtain the atoms involved.
698
699 pull-group1-weights: 
700 :    Optional relative weights which are multiplied with the masses of the atoms to give the total weight for the COM. The number should be 0, meaning all 1, or the number of atoms in the pull group.
701
702 pull-group1-pbcatom: (0)
703 :    The reference atom for the treatment of periodic boundary conditions inside the group (this has no effect on the treatment of the pbc between groups). This option is only important when the diameter of the pull group is larger than half the shortest box vector. For determining the COM, all atoms in the group are put at their periodic image which is closest to **pull-group1-pbcatom**. A value of 0 means that the middle atom (number wise) is used. This parameter is not used with geometry **cylinder**. A value of -1 turns on cosine weighting, which is useful for a group of molecules in a periodic system, _e.g._ a water slab (see Engin et al. J. Chem. Phys. B 2010).
704
705 pull-coord1-groups: 
706 :    The two groups indices should be given on which this pull coordinate will operate. The first index can be 0, in which case an absolute reference of **pull-coord1-origin** is used. With an absolute reference the system is no longer translation invariant and one should think about what to do with the center of mass motion.
707
708 pull-coord1-origin: (0.0 0.0 0.0)
709 :    The pull reference position for use with an absolute reference.
710
711 pull-coord1-vec: (0.0 0.0 0.0)
712 :    The pull direction. [gmx grompp] normalizes the vector.
713
714 pull-coord1-init: (0.0) [nm]
715 :    The reference distance at t=0.
716
717 pull-coord1-rate: (0) [nm/ps]
718 :    The rate of change of the reference position.
719
720 pull-coord1-k: (0) [kJ mol-1 nm-2] / [kJ mol-1 nm-1]
721 :    The force constant. For umbrella pulling this is the harmonic force constant in [kJ mol-1 nm-2]. For constant force pulling this is the force constant of the linear potential, and thus the negative (!) of the constant force in [kJ mol-1 nm-1].
722
723 pull-coord1-kB: (pull-k1) [kJ mol-1 nm-2] / [kJ mol-1 nm-1]
724 :    As **pull-coord1-k**, but for state B. This is only used when **free-energy** is turned on. The force constant is then (1 - lambda) * **pull-coord1-k** + lambda * **pull-coord1-kB**.
725
726
727 ### NMR refinement
728
729 disre:
730 :   + **no**    
731     ignore distance restraint information in topology file
732
733     + **simple**    
734     simple (per-molecule) distance restraints.
735
736     + **ensemble**
737     distance restraints over an ensemble of molecules in one simulation box. Normally, one would perform ensemble averaging over multiple subsystems, each in a separate box, using `mdrun -multi`. Supply `topol0.tpr`, `topol1.tpr`, ... with different coordinates and/or velocities. The environment variable `GMX_DISRE_ENSEMBLE_SIZE` sets the number of systems within each ensemble (usually equal to the `mdrun -multi` value).
738
739 disre-weighting:
740 :   + **equal**     (default)
741     divide the restraint force equally over all atom pairs in the restraint
742
743     + **conservative**    
744     the forces are the derivative of the restraint potential, this results in an weighting of the atom pairs to the reciprocal seventh power of the displacement. The forces are conservative when **disre-tau** is zero.
745
746 disre-mixed:
747 :   + **no**    
748     the violation used in the calculation of the restraint force is the time-averaged violation 
749
750     + **yes**    
751     the violation used in the calculation of the restraint force is the square root of the product of the time-averaged violation and the instantaneous violation
752
753 disre-fc: (1000) [kJ mol-1 nm-2]
754 :    force constant for distance restraints, which is multiplied by a (possibly) different factor for each restraint given in the `fac` column of the interaction in the topology file.
755
756 disre-tau: (0) [ps]
757 :    time constant for distance restraints running average. A value of zero turns off time averaging.
758
759 nstdisreout: (100) [steps]
760 :    period between steps when the running time-averaged and instantaneous distances of all atom pairs involved in restraints are written to the energy file (can make the energy file very large)
761
762 orire:
763 :   + **no**    
764     ignore orientation restraint information in topology file
765
766     + **yes**    
767     use orientation restraints, ensemble averaging can be performed with `mdrun -multi`
768
769 orire-fc: (0) [kJ mol]
770 :    force constant for orientation restraints, which is multiplied by a (possibly) different weight factor for each restraint, can be set to zero to obtain the orientations from a free simulation
771
772 orire-tau: (0) [ps]
773 :    time constant for orientation restraints running average. A value of zero turns off time averaging.
774
775 orire-fitgrp: 
776 :    fit group for orientation restraining. This group of atoms is used to determine the rotation **R** of the system with respect to the reference orientation. The reference orientation is the starting conformation of the first subsystem. For a protein, backbone is a reasonable choice
777
778 nstorireout: (100) [steps]
779 :    period between steps when the running time-averaged and instantaneous orientations for all restraints, and the molecular order tensor are written to the energy file (can make the energy file very large)
780   
781
782 ### Free energy calculations
783
784 free-energy:
785 :   + **no**    
786     Only use topology A.
787
788     + **yes**    
789     Interpolate between topology A (lambda=0) to topology B (lambda=1) and write the derivative of the Hamiltonian with respect to lambda (as specified with **dhdl-derivatives**), or the Hamiltonian differences with respect to other lambda values (as specified with **foreign-lambda**) to the energy file and/or to `dhdl.xvg`, where they can be processed by, for example [gmx bar]. The potentials, bond-lengths and angles are interpolated linearly as described in the manual. When **sc-alpha** is larger than zero, soft-core potentials are used for the LJ and Coulomb interactions.
790
791     + **expanded**    
792      Turns on expanded ensemble simulation, where the alchemical state becomes a dynamic variable, allowing jumping between different Hamiltonians. See the expanded ensemble options for controlling how expanded ensemble simulations are performed. The different Hamiltonians used in expanded ensemble simulations are defined by the other free energy options.
793
794 init-lambda: (-1)
795 :    starting value for lambda (float). Generally, this should only be used with slow growth (_i.e._ nonzero **delta-lambda**). In other cases, **init-lambda-state** should be specified instead. Must be greater than or equal to 0.
796
797 delta-lambda: (0)
798 :    increment per time step for lambda
799
800 init-lambda-state: (-1)
801 :    starting value for the lambda state (integer). Specifies which columm of the lambda vector (**coul-lambdas**, **vdw-lambdas**, **bonded-lambdas**, **restraint-lambdas**, **mass-lambdas**, **temperature-lambdas**, **fep-lambdas**) should be used. This is a zero-based index: **init-lambda-state** 0 means the first column, and so on.
802
803 fep-lambdas: ()
804 :    Zero, one or more lambda values for which Delta H values will be determined and written to dhdl.xvg every **nstdhdl** steps. Values must be between 0 and 1. Free energy differences between different lambda values can then be determined with [gmx bar]. **fep-lambdas** is different from the other `-lambdas` keywords because all components of the lambda vector that are not specified will use **fep-lambdas** (including restraint-lambdas and therefore the pull code restraints).
805
806 coul-lambdas: ()
807 :    Zero, one or more lambda values for which Delta H values will be determined and written to dhdl.xvg every **nstdhdl** steps. Values must be between 0 and 1. Only the electrostatic interactions are controlled with this component of the lambda vector (and only if the lambda=0 and lambda=1 states have differing electrostatic interactions).
808
809 vdw-lambdas: ()
810 :    Zero, one or more lambda values for which Delta H values will be determined and written to dhdl.xvg every **nstdhdl** steps. Values must be between 0 and 1. Only the van der Waals interactions are controlled with this component of the lambda vector.
811
812 bonded-lambdas: ()
813 :    Zero, one or more lambda values for which Delta H values will be determined and written to dhdl.xvg every **nstdhdl** steps. Values must be between 0 and 1. Only the bonded interactions are controlled with this component of the lambda vector.
814
815 restraint-lambdas: ()
816 :    Zero, one or more lambda values for which Delta H values will be determined and written to dhdl.xvg every **nstdhdl** steps. Values must be between 0 and 1. Only the restraint interactions: dihedral restraints, and the pull code restraints are controlled with this component of the lambda vector. 
817
818 mass-lambdas: ()
819 :    Zero, one or more lambda values for which Delta H values will be determined and written to dhdl.xvg every **nstdhdl** steps. Values must be between 0 and 1. Only the particle masses are controlled with this component of the lambda vector.
820
821 temperature-lambdas: ()
822 :    Zero, one or more lambda values for which Delta H values will be determined and written to dhdl.xvg every **nstdhdl** steps. Values must be between 0 and 1. Only the temperatures controlled with this component of the lambda vector. Note that these lambdas should not be used for replica exchange, only for simulated tempering.
823
824 calc-lambda-neighbors (1)
825 :    Controls the number of lambda values for which Delta H values will be calculated and written out, if **init-lambda-state** has been set. A positive value will limit the number of lambda points calculated to only the nth neighbors of **init-lambda-state**: for example, if **init-lambda-state** is 5 and this parameter has a value of 2, energies for lambda points 3-7 will be calculated and writen out. A value of -1 means all lambda points will be written out. For normal BAR such as with [gmx bar], a value of 1 is sufficient, while for MBAR -1 should be used.
826
827 sc-alpha: (0)
828 :    the soft-core alpha parameter, a value of 0 results in linear interpolation of the LJ and Coulomb interactions
829
830 sc-r-power: (6)
831 :    the power of the radial term in the soft-core equation. Possible values are 6 and 48. 6 is more standard, and is the default. When 48 is used, then sc-alpha should generally be much lower (between 0.001 and 0.003).
832
833 sc-coul: (no)
834 :    Whether to apply the soft core free energy interaction transformation to the Columbic interaction of a molecule. Default is no, as it is generally more efficient to turn off the Coulomic interactions linearly before turning off the van der Waals interactions.
835
836 sc-power: (0)
837 :    the power for lambda in the soft-core function, only the values 1 and 2 are supported
838
839 sc-sigma: (0.3) [nm]
840 :    the soft-core sigma for particles which have a C6 or C12 parameter equal to zero or a sigma smaller than **sc-sigma**
841
842 couple-moltype:
843 :    Here one can supply a molecule type (as defined in the topology) for calculating solvation or coupling free energies. There is a special option **system** that couples all molecule types in the system. This can be useful for equilibrating a system starting from (nearly) random coordinates. **free-energy** has to be turned on. The Van der Waals interactions and/or charges in this molecule type can be turned on or off between lambda=0 and lambda=1, depending on the settings of **couple-lambda0** and **couple-lambda1**. If you want to decouple one of several copies of a molecule, you need to copy and rename the molecule definition in the topology.
844
845 couple-lambda0:
846 :   + **vdw-q**    
847     all interactions are on at lambda=0
848
849     + **vdw**  
850     the charges are zero (no Coulomb interactions) at lambda=0
851
852     + **q**  
853     the Van der Waals interactions are turned at lambda=0; soft-core interactions will be required to avoid singularities
854
855     + **none**  
856     the Van der Waals interactions are turned off and the charges are zero at lambda=0; soft-core interactions will be required to avoid singularities.
857
858 couple-lambda1:
859 :     analogous to **couple-lambda1**, but for lambda=1
860
861 couple-intramol:
862 :   + **no**   
863     All intra-molecular non-bonded interactions for moleculetype **couple-moltype** are replaced by exclusions and explicit pair interactions. In this manner the decoupled state of the molecule corresponds to the proper vacuum state without periodicity effects.
864
865     + **yes**  
866     The intra-molecular Van der Waals and Coulomb interactions are also turned on/off. This can be useful for partitioning free-energies of relatively large molecules, where the intra-molecular non-bonded interactions might lead to kinetically trapped vacuum conformations. The 1-4 pair interactions are not turned off.
867
868 * **nstdhdl: (100)**
869     the frequency for writing dH/dlambda and possibly Delta H to dhdl.xvg, 0 means no ouput, should be a multiple of **nstcalcenergy**.
870
871 dhdl-derivatives: (yes)
872 :    If yes (the default), the derivatives of the Hamiltonian with respect to lambda at each **nstdhdl** step are written out. These values are needed for interpolation of linear energy differences with [gmx bar] (although the same can also be achieved with the right **foreign lambda** setting, that may not be as flexible), or with thermodynamic integration
873
874 dhdl-print-energy: (no)
875 :     Include either the total or the potential energy in the dhdl file. Options are 'no', 'potential', or 'total'. This information is needed for later free energy analysis if the states of interest are at different temperatures. If all states are at the same temperature, this information is not needed. 'potential' is useful in case one is using `mdrun -rerun` to generate the `dhdl.xvg` file. When rerunning from an existing trajectory, the kinetic energy will often not be correct, and thus one must compute the residual free energy from the potential alone, with the kinetic energy component computed analytically. 
876
877 separate-dhdl-file: (yes)
878 :   + **yes**    
879     the free energy values that are calculated (as specified with the **foreign-lambda** and **dhdl-derivatives** settings) are written out to a separate file, with the default name `dhdl.xvg`. This file can be used directly with [gmx bar].
880
881     + **no**    
882     The free energy values are written out to the energy output file (`ener.edr`, in accumulated blocks at every **nstenergy** steps), where they can be extracted with [gmx energy] or used directly with [gmx bar].
883
884 dh-hist-size: (0)
885 :    If nonzero, specifies the size of the histogram into which the Delta H values (specified with **foreign-lambda**) and the derivative dH/dl values are binned, and written to ener.edr. This can be used to save disk space while calculating free energy differences. One histogram gets written for each **foreign lambda** and two for the dH/dl, at every **nstenergy** step. Be aware that incorrect histogram settings (too small size or too wide bins) can introduce errors. Do not use histograms unless you're certain you need it.
886
887 dh-hist-spacing (0.1)
888 :    Specifies the bin width of the histograms, in energy units. Used in conjunction with **dh-hist-size**. This size limits the accuracy with which free energies can be calculated. Do not use histograms unless you're certain you need it.
889
890
891 ### Expanded Ensemble calculations
892
893 nstexpanded
894 :    The number of integration steps beween attempted moves changing the system Hamiltonian in expanded ensemble simulations. Must be a multiple of **nstcalcenergy**, but can be greater or less than **nstdhdl**.
895 lmc-stats:
896 :   + **no**    
897     No Monte Carlo in state space is performed.
898
899     + **metropolis-transition**    
900      Uses the Metropolis weights to update the expanded ensemble weight of each state. Min{1,exp(-(beta_new u_new - beta_old u_old)}
901
902     + **barker-transition**    
903      Uses the Barker transition critera to update the expanded ensemble weight of each state i, defined by exp(-beta_new u_new)/[exp(-beta_new u_new)+exp(-beta_old u_old)
904
905     + **wang-landau**    
906     Uses the Wang-Landau algorithm (in state space, not energy space) to update the expanded ensemble weights.
907
908     + **min-variance**    
909     Uses the minimum variance updating method of Escobedo et al. to update the expanded ensemble weights. Weights will not be the free energies, but will rather emphasize states that need more sampling to give even uncertainty.
910
911 lmc-mc-move:
912 :   + **no**    
913     No Monte Carlo in state space is performed.
914
915     + **metropolis-transition**    
916      Randomly chooses a new state up or down, then uses the Metropolis critera to decide whether to accept or reject: Min{1,exp(-(beta_new u_new - beta_old u_old)}
917
918     + **barker-transition**    
919      Randomly chooses a new state up or down, then uses the Barker transition critera to decide whether to accept or reject: exp(-beta_new u_new)/[exp(-beta_new u_new)+exp(-beta_old u_old)]
920
921     + **gibbs**    
922      Uses the conditional weights of the state given the coordinate (exp(-beta_i u_i) / sum_k exp(beta_i u_i) to decide which state to move to.
923
924     + **metropolized-gibbs**    
925           Uses the conditional weights of the state given the coordinate (exp(-beta_i u_i) / sum_k exp(beta_i u_i) to decide which state to move to, EXCLUDING the current state, then uses a rejection step to ensure detailed balance. Always more efficient that Gibbs, though only marginally so in many situations, such as when only the nearest neighbors have decent phase space overlap.
926
927 lmc-seed: (-1)
928 :     random seed to use for Monte Carlo moves in state space. When **lmc-seed** is set to -1, a pseudo random seed is us
929
930 mc-temperature:
931 :     Temperature used for acceptance/rejection for Monte Carlo moves. If not specified, the temperature of the simulation specified in the first group of **ref_t** is used.
932
933 wl-ratio: (0.8)
934 :    The cutoff for the histogram of state occupancies to be reset, and the free energy incrementor to be changed from delta to delta * **wl-scale**. If we define the Nratio = (number of samples at each histogram) / (average number of samples at each histogram). **wl-ratio** of 0.8 means that means that the histogram is only considered flat if all Nratio > 0.8 AND simultaneously all 1/Nratio > 0.8.
935
936 wl-scale: (0.8)
937 :     Each time the histogram is considered flat, then the current value of the Wang-Landau incrementor for the free energies is multiplied by **wl-scale**. Value must be between 0 and 1.
938
939 init-wl-delta: (1.0)
940 :    The initial value of the Wang-Landau incrementor in kT. Some value near 1 kT is usually most efficient, though sometimes a value of 2-3 in units of kT works better if the free energy differences are large.
941
942 wl-oneovert: (no)
943 :    Set Wang-Landau incrementor to scale with 1/(simulation time) in the large sample limit. There is significant evidence that the standard Wang-Landau algorithms in state space presented here result in free energies getting 'burned in' to incorrect values that depend on the initial state. when **wl-oneovert** is true, then when the incrementor becomes less than 1/N, where N is the mumber of samples collected (and thus proportional to the data collection time, hence '1 over t'), then the Wang-Lambda incrementor is set to 1/N, decreasing every step. Once this occurs, **wl-ratio** is ignored, but the weights will still stop updating when the equilibration criteria set in **lmc-weights-equil** is achieved.
944
945 lmc-repeats: (1)
946 :    Controls the number of times that each Monte Carlo swap type is performed each iteration. In the limit of large numbers of Monte Carlo repeats, then all methods converge to Gibbs sampling. The value will generally not need to be different from 1.
947
948 lmc-gibbsdelta: (-1)
949 :     Limit Gibbs sampling to selected numbers of neighboring states. For Gibbs sampling, it is sometimes inefficient to perform Gibbs sampling over all of the states that are defined. A positive value of **lmc-gibbsdelta** means that only states plus or minus **lmc-gibbsdelta** are considered in exchanges up and down. A value of -1 means that all states are considered. For less than 100 states, it is probably not that expensive to include all states.
950
951 lmc-forced-nstart: (0)
952 :     Force initial state space sampling to generate weights. In order to come up with reasonable initial weights, this setting allows the simulation to drive from the initial to the final lambda state, with **lmc-forced-nstart** steps at each state before moving on to the next lambda state. If **lmc-forced-nstart** is sufficiently long (thousands of steps, perhaps), then the weights will be close to correct. However, in most cases, it is probably better to simply run the standard weight equilibration algorithms. **nst-transition-matrix: (-1)**
953     Frequency of outputting the expanded ensemble transition matrix. A negative number means it will only be printed at the end of the simulation.
954
955 symmetrized-transition-matrix: (no) 
956 :    Whether to symmetrize the empirical transition matrix. In the infinite limit the matrix will be symmetric, but will diverge with statistical noise for short timescales. Forced symmetrization, by using the matrix T_sym = 1/2 (T + transpose(T)), removes problems like the existence of (small magnitude) negative eigenvalues.
957
958 mininum-var-min: (100)
959 :     The **min-variance** strategy (option of **lmc-stats** is only valid for larger number of samples, and can get stuck if too few samples are used at each state. **mininum-var-min** is the minimum number of samples that each state that are allowed before the **min-variance** strategy is activated if selected.
960
961 init-lambda-weights: 
962 :    The initial weights (free energies) used for the expanded ensemble states. Default is a vector of zero weights. format is similar to the lambda vector settings in **fep-lambdas**, except the weights can be any floating point number. Units are kT. Its length must match the lambda vector lengths.
963
964 lmc-weights-equil: (no)
965 :   + **no**    
966     Expanded ensemble weights continue to be updated throughout the simulation.
967
968     + **yes**    
969     The input expanded ensemble weights are treated as equilibrated, and are not updated throughout the simulation.
970
971     + **wl-delta**    
972     Expanded ensemble weight updating is stopped when the Wang-Landau incrementor falls below the value specified by **weight-equil-wl-delta**.
973
974     + **number-all-lambda**    
975     Expanded ensemble weight updating is stopped when the number of samples at all of the lambda states is greater than the value specified by **weight-equil-number-all-lambda**.
976
977     + **number-steps**    
978     Expanded ensemble weight updating is stopped when the number of steps is greater than the level specified by **weight-equil-number-steps**.
979
980     + **number-samples**    
981     Expanded ensemble weight updating is stopped when the number of total samples across all lambda states is greater than the level specified by **weight-equil-number-samples**.
982
983     + **count-ratio**    
984     Expanded ensemble weight updating is stopped when the ratio of samples at the least sampled lambda state and most sampled lambda state greater than the value specified by **weight-equil-count-ratio**.
985
986 simulated-tempering: (no)
987 :    Turn simulated tempering on or off. Simulated tempering is implemented as expanded ensemble sampling with different temperatures instead of different Hamiltonians.
988
989 sim-temp-low: (300) [K]
990 :    Low temperature for simulated tempering.
991
992 sim-temp-high: (300) [K]
993 :    High temperature for simulated tempering.
994
995 simulated-tempering-scaling: (linear)
996 :    Controls the way that the temperatures at intermediate lambdas are calculated from the **temperature-lambda** part of the lambda vector.
997
998     + **linear**    
999     Linearly interpolates the temperatures using the values of **temperature-lambda**, _i.e._ if **sim-temp-low**=300, **sim-temp-high**=400, then lambda=0.5 correspond to a temperature of 350. A nonlinear set of temperatures can always be implemented with uneven spacing in lambda.
1000
1001     + **geometric**    
1002      Interpolates temperatures geometrically between **sim-temp-low** and **sim-temp-high**. The i:th state has temperature **sim-temp-low** * (**sim-temp-high**/**sim-temp-low**) raised to the power of (i/(ntemps-1)). This should give roughly equal exchange for constant heat capacity, though of course things simulations that involve protein folding have very high heat capacity peaks.
1003
1004     + **exponential**    
1005      Interpolates temperatures exponentially between **sim-temp-low** and **sim-temp-high**. The ith state has temperature **sim-temp-low** + (**sim-temp-high**-**sim-temp-low**)*((exp(**temperature-lambdas**[i])-1)/(exp(1.0)-1)).
1006
1007
1008 ### Non-equilibrium MD
1009
1010 acc-grps: 
1011 :    groups for constant acceleration (_e.g._ `Protein Sol`) all atoms in groups Protein and Sol will experience constant acceleration as specified in the **accelerate** line
1012
1013 accelerate: (0) [nm ps-2]
1014 :    acceleration for **acc-grps**; x, y and z for each group (_e.g._ `0.1 0.0 0.0 -0.1 0.0 0.0` means that first group has constant acceleration of 0.1 nm ps-2 in X direction, second group the opposite).
1015
1016 freezegrps: 
1017 :    Groups that are to be frozen (_i.e._ their X, Y, and/or Z position will not be updated; _e.g._ `Lipid SOL`). **freezedim** specifies for which dimension the freezing applies. To avoid spurious contibrutions 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.
1018
1019 freezedim: 
1020 :    dimensions for which groups in **freezegrps** should be frozen, specify `Y` or `N` for X, Y and Z and for each group (_e.g._ `Y Y N N N N` means that particles in the first group can move only in Z direction. The particles in the second group can move in any direction).
1021
1022 cos-acceleration: (0) [nm ps-2]
1023 :    the amplitude of the acceleration profile for calculating the viscosity. The acceleration is in the X-direction and the magnitude is **cos-acceleration** cos(2 pi z/boxheight). Two terms are added to the energy file: the amplitude of the velocity profile and 1/viscosity.
1024
1025 deform: (0 0 0 0 0 0) [nm ps-1]
1026 :    The velocities of deformation for the box elements: a(x) b(y) c(z) b(x) c(x) c(y). Each step the box elements for which **deform** is non-zero are calculated as: box(ts)+(t-ts)*deform, off-diagonal elements are corrected for periodicity. The coordinates are transformed accordingly. Frozen degrees of freedom are (purposely) also transformed. The time ts is set to t at the first step and at steps at which x and v are written to trajectory to ensure exact restarts. Deformation can be used together with semiisotropic or anisotropic pressure coupling when the appropriate compressibilities are set to zero. The diagonal elements can be used to strain a solid. The off-diagonal elements can be used to shear a solid or a liquid.
1027   
1028
1029 ### Electric fields
1030
1031 E-x ; E-y ; E-z:
1032 :    If you want to use an electric field in a direction, enter 3 numbers after the appropriate **E-***, the first number: the number of cosines, only 1 is implemented (with frequency 0) so enter 1, the second number: the strength of the electric field in **V nm-1**, the third number: the phase of the cosine, you can enter any number here since a cosine of frequency zero has no phase.
1033
1034 E-xt; E-yt; E-zt: 
1035 :    not implemented yet
1036
1037
1038 ### Mixed quantum/classical molecular dynamics
1039
1040 QMMM:
1041 :   + **no**    
1042     No QM/MM.
1043
1044     + **yes**    
1045     Do a QM/MM simulation. Several groups can be described at different QM levels separately. These are specified in the **QMMM-grps** field separated by spaces. The level of _ab initio_ theory at which the groups are described is specified by **QMmethod** and **QMbasis** Fields. Describing the groups at different levels of theory is only possible with the ONIOM QM/MM scheme, specified by **QMMMscheme**.
1046
1047 QMMM-grps:
1048 :    groups to be descibed at the QM level
1049
1050 QMMMscheme:
1051 :   + **normal**    
1052     normal QM/MM. There can only be one **QMMM-grps** that is modelled at the **QMmethod** and **QMbasis** level of _ab initio_ theory. The rest of the system is described at the MM level. The QM and MM subsystems interact as follows: MM point charges are included in the QM one-electron hamiltonian and all Lennard-Jones interactions are described at the MM level.
1053
1054     + **ONIOM**    
1055     The interaction between the subsystem is described using the ONIOM method by Morokuma and co-workers. There can be more than one **QMMM-grps** each modeled at a different level of QM theory (**QMmethod** and **QMbasis**). 
1056
1057 QMmethod: (RHF)
1058 :    Method used to compute the energy and gradients on the QM atoms. Available methods are AM1, PM3, RHF, UHF, DFT, B3LYP, MP2, CASSCF, and MMVB. For CASSCF, the number of electrons and orbitals included in the active space is specified by **CASelectrons** and **CASorbitals**. 
1059
1060 QMbasis: (STO-3G)
1061 :    Basis set used to expand the electronic wavefuntion. Only Gaussian basis sets are currently available, _i.e._ `STO-3G, 3-21G, 3-21G*, 3-21+G*, 6-21G, 6-31G, 6-31G*, 6-31+G*,` and `6-311G`.
1062
1063 QMcharge: (0) [integer]
1064 :    The total charge in `e` of the **QMMM-grps**. In case there are more than one **QMMM-grps**, the total charge of each ONIOM layer needs to be specified separately.
1065
1066 QMmult: (1) [integer]
1067 :    The multiplicity of the **QMMM-grps**. In case there are more than one **QMMM-grps**, the multiplicity of each ONIOM layer needs to be specified separately.
1068
1069 CASorbitals: (0) [integer]
1070 :    The number of orbitals to be included in the active space when doing a CASSCF computation.
1071
1072 CASelectrons: (0) [integer]
1073 :    The number of electrons to be included in the active space when doing a CASSCF computation.
1074
1075 SH:
1076 :   + **no**    
1077     No surface hopping. The system is always in the electronic ground-state.
1078
1079     + **yes**    
1080     Do a QM/MM MD simulation on the excited state-potential energy surface and enforce a _diabatic_ hop to the ground-state when the system hits the conical intersection hyperline in the course the simulation. This option only works in combination with the CASSCF method.
1081   
1082
1083 ### Implicit solvent
1084
1085 implicit-solvent:
1086 :   + **no**    
1087     No implicit solvent
1088
1089     + **GBSA**    
1090     Do a simulation with implicit solvent using the Generalized Born formalism. Three different methods for calculating the Born radii are available, Still, HCT and OBC. These are specified with the **gb-algorithm** field. The non-polar solvation is specified with the **sa-algorithm** field.
1091
1092 gb-algorithm:
1093 :   + **Still**    
1094     Use the Still method to calculate the Born radii
1095
1096     + **HCT**    
1097     Use the Hawkins-Cramer-Truhlar method to calculate the Born radii
1098
1099     + **OBC**    
1100     Use the Onufriev-Bashford-Case method to calculate the Born radii
1101
1102 nstgbradii: (1) [steps]
1103 :    Frequency to (re)-calculate the Born radii. For most practial purposes, setting a value larger than 1 violates energy conservation and leads to unstable trajectories.
1104
1105 rgbradii: (1.0) [nm]
1106 :    Cut-off for the calculation of the Born radii. Currently must be equal to rlist
1107
1108 gb-epsilon-solvent: (80)
1109 :    Dielectric constant for the implicit solvent
1110
1111 gb-saltconc: (0) [M]
1112 :    Salt concentration for implicit solvent models, currently not used
1113
1114 gb-obc-alpha (1); gb-obc-beta (0.8); gb-obc-gamma (4.85);
1115 :    Scale factors for the OBC model. Default values are OBC(II). Values for OBC(I) are 0.8, 0 and 2.91 respectively
1116
1117 gb-dielectric-offset: (0.009) [nm]
1118 :    Distance for the di-electric offset when calculating the Born radii. This is the offset between the center of each atom the center of the polarization energy for the corresponding atom
1119
1120 sa-algorithm
1121 :   + **Ace-approximation**    
1122     Use an Ace-type approximation (default)
1123
1124     + **None**    
1125     No non-polar solvation calculation done. For GBSA only the polar part gets calculated
1126
1127 sa-surface-tension: [kJ mol-1 nm-2]
1128 :    Default value for surface tension with SA algorithms. The default value is -1; Note that if this default value is not changed it will be overridden by [gmx grompp] using values that are specific for the choice of radii algorithm (0.0049 kcal/mol/Angstrom2 for Still, 0.0054 kcal/mol/Angstrom2 for HCT/OBC) Setting it to 0 will while using an sa-algorithm other than None means no non-polar calculations are done. 
1129   
1130
1131 ### Adaptive Resolution Simulation
1132
1133 adress: (no)
1134 :    Decide whether the AdResS feature is turned on.
1135
1136 adress-type: (Off)
1137 :   + **Off**    
1138     Do an AdResS simulation with weight equal 1, which is equivalent to an explicit (normal) MD simulation. The difference to disabled AdResS is that the AdResS variables are still read-in and hence are defined.
1139
1140     + **Constant**    
1141     Do an AdResS simulation with a constant weight, **adress-const-wf** defines the value of the weight
1142
1143     + **XSplit**    
1144     Do an AdResS simulation with simulation box split in x-direction, so basically the weight is only a function of the x coordinate and all distances are measured using the x coordinate only.
1145
1146     + **Sphere**    
1147     Do an AdResS simulation with spherical explicit zone.
1148
1149 adress-const-wf: (1)
1150 :    Provides the weight for a constant weight simulation (**adress-type**=Constant)
1151
1152 adress-ex-width: (0)
1153 :    Width of the explicit zone, measured from **adress-reference-coords**.
1154
1155 adress-hy-width: (0)
1156 :    Width of the hybrid zone.
1157
1158 adress-reference-coords: (0,0,0)
1159 :    Position of the center of the explicit zone. Periodic boundary conditions apply for measuring the distance from it.
1160
1161 adress-cg-grp-names
1162 :    The names of the coarse-grained energy groups. All other energy groups are considered explicit and their interactions will be automatically excluded with the coarse-grained groups.
1163 * **adress-site: (COM)**  The mapping point from which the weight is calculated.
1164
1165     + **COM**    
1166     The weight is calculated from the center of mass of each charge group.
1167
1168     + **COG**    
1169     The weight is calculated from the center of geometry of each charge group.
1170
1171     + **Atom**    
1172     The weight is calculated from the position of 1st atom of each charge group.
1173
1174     + **AtomPerAtom**    
1175     The weight is calculated from the position of each individual atom.
1176
1177 adress-interface-correction: (Off)
1178 :   + **Off**    
1179     Do not a apply any interface correction.
1180
1181     + **thermoforce**    
1182     Apply thermodynamic force interface correction. The table can be specified using the `-tabletf` option of [mdrun]. The table should contain the potential and force (acting on molecules) as function of the distance from **adress-reference-coords**.
1183
1184 adress-tf-grp-names
1185 :    The names of the energy groups to which the **thermoforce** is applied if enabled in **adress-interface-correction**. If no group is given the default table is applied.
1186
1187 adress-ex-forcecap: (0)
1188 :    Cap the force in the hybrid region, useful for big molecules. 0 disables force capping.
1189   
1190
1191 ### User defined thingies
1192
1193 user1-grps; user2-grps; userint1 (0); userint2 (0); userint3 (0); userint4 (0); userreal1 (0); userreal2 (0); userreal3 (0); userreal4 (0)
1194 :    These you can use if you modify code. You can pass integers and reals to your subroutine. Check the inputrec definition in `src/include/types/inputrec.h`