Merge branch 'release-4-5-patches' of git@git.gromacs.org:gromacs into release-4...
[gromacs/rigid-bodies.git] / man / man1 / mdrun.1
blob191bffd54ce21a08352a251887bda078a2a2e4bf
1 .TH mdrun 1 "Thu 26 Aug 2010" "" "GROMACS suite, VERSION 4.5"
2 .SH NAME
3 mdrun - performs a simulation, do a normal mode analysis or an energy minimization
5 .B VERSION 4.5
6 .SH SYNOPSIS
7 \f3mdrun\fP
8 .BI "\-s" " topol.tpr "
9 .BI "\-o" " traj.trr "
10 .BI "\-x" " traj.xtc "
11 .BI "\-cpi" " state.cpt "
12 .BI "\-cpo" " state.cpt "
13 .BI "\-c" " confout.gro "
14 .BI "\-e" " ener.edr "
15 .BI "\-g" " md.log "
16 .BI "\-dhdl" " dhdl.xvg "
17 .BI "\-field" " field.xvg "
18 .BI "\-table" " table.xvg "
19 .BI "\-tablep" " tablep.xvg "
20 .BI "\-tableb" " table.xvg "
21 .BI "\-rerun" " rerun.xtc "
22 .BI "\-tpi" " tpi.xvg "
23 .BI "\-tpid" " tpidist.xvg "
24 .BI "\-ei" " sam.edi "
25 .BI "\-eo" " sam.edo "
26 .BI "\-j" " wham.gct "
27 .BI "\-jo" " bam.gct "
28 .BI "\-ffout" " gct.xvg "
29 .BI "\-devout" " deviatie.xvg "
30 .BI "\-runav" " runaver.xvg "
31 .BI "\-px" " pullx.xvg "
32 .BI "\-pf" " pullf.xvg "
33 .BI "\-mtx" " nm.mtx "
34 .BI "\-dn" " dipole.ndx "
35 .BI "\-[no]h" ""
36 .BI "\-[no]version" ""
37 .BI "\-nice" " int "
38 .BI "\-deffnm" " string "
39 .BI "\-xvg" " enum "
40 .BI "\-[no]pd" ""
41 .BI "\-dd" " vector "
42 .BI "\-nt" " int "
43 .BI "\-npme" " int "
44 .BI "\-ddorder" " enum "
45 .BI "\-[no]ddcheck" ""
46 .BI "\-rdd" " real "
47 .BI "\-rcon" " real "
48 .BI "\-dlb" " enum "
49 .BI "\-dds" " real "
50 .BI "\-gcom" " int "
51 .BI "\-[no]v" ""
52 .BI "\-[no]compact" ""
53 .BI "\-[no]seppot" ""
54 .BI "\-pforce" " real "
55 .BI "\-[no]reprod" ""
56 .BI "\-cpt" " real "
57 .BI "\-[no]cpnum" ""
58 .BI "\-[no]append" ""
59 .BI "\-maxh" " real "
60 .BI "\-multi" " int "
61 .BI "\-replex" " int "
62 .BI "\-reseed" " int "
63 .BI "\-[no]ionize" ""
64 .SH DESCRIPTION
65 \&The mdrun program is the main computational chemistry engine
66 \&within GROMACS. Obviously, it performs Molecular Dynamics simulations,
67 \&but it can also perform Stochastic Dynamics, Energy Minimization,
68 \&test particle insertion or (re)calculation of energies.
69 \&Normal mode analysis is another option. In this case mdrun
70 \&builds a Hessian matrix from single conformation.
71 \&For usual Normal Modes\-like calculations, make sure that
72 \&the structure provided is properly energy\-minimized.
73 \&The generated matrix can be diagonalized by g_nmeig.
76 \&The mdrun program reads the run input file (\fB \-s\fR)
77 \&and distributes the topology over nodes if needed.
78 \&mdrun produces at least four output files.
79 \&A single log file (\fB \-g\fR) is written, unless the option
80 \&\fB \-seppot\fR is used, in which case each node writes a log file.
81 \&The trajectory file (\fB \-o\fR), contains coordinates, velocities and
82 \&optionally forces.
83 \&The structure file (\fB \-c\fR) contains the coordinates and
84 \&velocities of the last step.
85 \&The energy file (\fB \-e\fR) contains energies, the temperature,
86 \&pressure, etc, a lot of these things are also printed in the log file.
87 \&Optionally coordinates can be written to a compressed trajectory file
88 \&(\fB \-x\fR).
91 \&The option \fB \-dhdl\fR is only used when free energy calculation is
92 \&turned on.
95 \&When mdrun is started using MPI with more than 1 node, parallelization
96 \&is used. By default domain decomposition is used, unless the \fB \-pd\fR
97 \&option is set, which selects particle decomposition.
100 \&With domain decomposition, the spatial decomposition can be set
101 \&with option \fB \-dd\fR. By default mdrun selects a good decomposition.
102 \&The user only needs to change this when the system is very inhomogeneous.
103 \&Dynamic load balancing is set with the option \fB \-dlb\fR,
104 \&which can give a significant performance improvement,
105 \&especially for inhomogeneous systems. The only disadvantage of
106 \&dynamic load balancing is that runs are no longer binary reproducible,
107 \&but in most cases this is not important.
108 \&By default the dynamic load balancing is automatically turned on
109 \&when the measured performance loss due to load imbalance is 5% or more.
110 \&At low parallelization these are the only important options
111 \&for domain decomposition.
112 \&At high parallelization the options in the next two sections
113 \&could be important for increasing the performace.
117 \&When PME is used with domain decomposition, separate nodes can
118 \&be assigned to do only the PME mesh calculation;
119 \&this is computationally more efficient starting at about 12 nodes.
120 \&The number of PME nodes is set with option \fB \-npme\fR,
121 \&this can not be more than half of the nodes.
122 \&By default mdrun makes a guess for the number of PME
123 \&nodes when the number of nodes is larger than 11 or performance wise
124 \&not compatible with the PME grid x dimension.
125 \&But the user should optimize npme. Performance statistics on this issue
126 \&are written at the end of the log file.
127 \&For good load balancing at high parallelization, the PME grid x and y
128 \&dimensions should be divisible by the number of PME nodes
129 \&(the simulation will run correctly also when this is not the case).
133 \&This section lists all options that affect the domain decomposition.
136 \&Option \fB \-rdd\fR can be used to set the required maximum distance
137 \&for inter charge\-group bonded interactions.
138 \&Communication for two\-body bonded interactions below the non\-bonded
139 \&cut\-off distance always comes for free with the non\-bonded communication.
140 \&Atoms beyond the non\-bonded cut\-off are only communicated when they have
141 \&missing bonded interactions; this means that the extra cost is minor
142 \&and nearly indepedent of the value of \fB \-rdd\fR.
143 \&With dynamic load balancing option \fB \-rdd\fR also sets
144 \&the lower limit for the domain decomposition cell sizes.
145 \&By default \fB \-rdd\fR is determined by mdrun based on
146 \&the initial coordinates. The chosen value will be a balance
147 \&between interaction range and communication cost.
150 \&When inter charge\-group bonded interactions are beyond
151 \&the bonded cut\-off distance, mdrun terminates with an error message.
152 \&For pair interactions and tabulated bonds
153 \&that do not generate exclusions, this check can be turned off
154 \&with the option \fB \-noddcheck\fR.
157 \&When constraints are present, option \fB \-rcon\fR influences
158 \&the cell size limit as well.
159 \&Atoms connected by NC constraints, where NC is the LINCS order plus 1,
160 \&should not be beyond the smallest cell size. A error message is
161 \&generated when this happens and the user should change the decomposition
162 \&or decrease the LINCS order and increase the number of LINCS iterations.
163 \&By default mdrun estimates the minimum cell size required for P\-LINCS
164 \&in a conservative fashion. For high parallelization it can be useful
165 \&to set the distance required for P\-LINCS with the option \fB \-rcon\fR.
168 \&The \fB \-dds\fR option sets the minimum allowed x, y and/or z scaling
169 \&of the cells with dynamic load balancing. mdrun will ensure that
170 \&the cells can scale down by at least this factor. This option is used
171 \&for the automated spatial decomposition (when not using \fB \-dd\fR)
172 \&as well as for determining the number of grid pulses, which in turn
173 \&sets the minimum allowed cell size. Under certain circumstances
174 \&the value of \fB \-dds\fR might need to be adjusted to account for
175 \&high or low spatial inhomogeneity of the system.
179 \&The option \fB \-gcom\fR can be used to only do global communication
180 \&every n steps.
181 \&This can improve performance for highly parallel simulations
182 \&where this global communication step becomes the bottleneck.
183 \&For a global thermostat and/or barostat the temperature
184 \&and/or pressure will also only be updated every \-gcom steps.
185 \&By default it is set to the minimum of nstcalcenergy and nstlist.
188 \&With \fB \-rerun\fR an input trajectory can be given for which 
189 \&forces and energies will be (re)calculated. Neighbor searching will be
190 \&performed for every frame, unless \fB nstlist\fR is zero
191 \&(see the \fB .mdp\fR file).
194 \&ED (essential dynamics) sampling is switched on by using the \fB \-ei\fR
195 \&flag followed by an \fB .edi\fR file.
196 \&The \fB .edi\fR file can be produced using options in the essdyn
197 \&menu of the WHAT IF program. mdrun produces a \fB .edo\fR file that
198 \&contains projections of positions, velocities and forces onto selected
199 \&eigenvectors.
202 \&When user\-defined potential functions have been selected in the
203 \&\fB .mdp\fR file the \fB \-table\fR option is used to pass mdrun
204 \&a formatted table with potential functions. The file is read from
205 \&either the current directory or from the GMXLIB directory.
206 \&A number of pre\-formatted tables are presented in the GMXLIB dir,
207 \&for 6\-8, 6\-9, 6\-10, 6\-11, 6\-12 Lennard Jones potentials with
208 \&normal Coulomb.
209 \&When pair interactions are present a separate table for pair interaction
210 \&functions is read using the \fB \-tablep\fR option.
213 \&When tabulated bonded functions are present in the topology,
214 \&interaction functions are read using the \fB \-tableb\fR option.
215 \&For each different tabulated interaction type the table file name is
216 \&modified in a different way: before the file extension an underscore is
217 \&appended, then a b for bonds, an a for angles or a d for dihedrals
218 \&and finally the table number of the interaction type.
221 \&The options \fB \-px\fR and \fB \-pf\fR are used for writing pull COM
222 \&coordinates and forces when pulling is selected
223 \&in the \fB .mdp\fR file.
226 \&With \fB \-multi\fR multiple systems are simulated in parallel.
227 \&As many input files are required as the number of systems.
228 \&The system number is appended to the run input and each output filename,
229 \&for instance topol.tpr becomes topol0.tpr, topol1.tpr etc.
230 \&The number of nodes per system is the total number of nodes
231 \&divided by the number of systems.
232 \&One use of this option is for NMR refinement: when distance
233 \&or orientation restraints are present these can be ensemble averaged
234 \&over all the systems.
237 \&With \fB \-replex\fR replica exchange is attempted every given number
238 \&of steps. The number of replicas is set with the \fB \-multi\fR option,
239 \&see above.
240 \&All run input files should use a different coupling temperature,
241 \&the order of the files is not important. The random seed is set with
242 \&\fB \-reseed\fR. The velocities are scaled and neighbor searching
243 \&is performed after every exchange.
246 \&Finally some experimental algorithms can be tested when the
247 \&appropriate options have been given. Currently under
248 \&investigation are: polarizability, and X\-Ray bombardments.
252 \&The option \fB \-pforce\fR is useful when you suspect a simulation
253 \&crashes due to too large forces. With this option coordinates and
254 \&forces of atoms with a force larger than a certain value will
255 \&be printed to stderr.
259 \&Checkpoints containing the complete state of the system are written
260 \&at regular intervals (option \fB \-cpt\fR) to the file \fB \-cpo\fR,
261 \&unless option \fB \-cpt\fR is set to \-1.
262 \&The previous checkpoint is backed up to \fB state_prev.cpt\fR to
263 \&make sure that a recent state of the system is always available,
264 \&even when the simulation is terminated while writing a checkpoint.
265 \&With \fB \-cpnum\fR all checkpoint files are kept and appended
266 \&with the step number.
267 \&A simulation can be continued by reading the full state from file
268 \&with option \fB \-cpi\fR. This option is intelligent in the way that
269 \&if no checkpoint file is found, Gromacs just assumes a normal run and
270 \&starts from the first step of the tpr file. By default the output
271 \&will be appending to the existing output files. The checkpoint file
272 \&contains checksums of all output files, such that you will never
273 \&loose data when some output files are modified, corrupt or removed.
274 \&There are three scenarios with \fB \-cpi\fR:
276 \&* no files with matching names are present: new output files are written
278 \&* all files are present with names and checksums matching those stored
279 \&in the checkpoint file: files are appended
281 \&* otherwise no files are modified and a fatal error is generated
283 \&With \fB \-noappend\fR new output files are opened and the simulation
284 \&part number is added to all output file names.
285 \&Note that in all cases the checkpoint file itself is not renamed
286 \&and will be overwritten, unless its name does not match
287 \&the \fB \-cpo\fR option.
291 \&With checkpointing the output is appended to previously written
292 \&output files, unless \fB \-noappend\fR is used or none of the previous
293 \&output files are present (except for the checkpoint file).
294 \&The integrity of the files to be appended is verified using checksums
295 \&which are stored in the checkpoint file. This ensures that output can
296 \&not be mixed up or corrupted due to file appending. When only some
297 \&of the previous output files are present, a fatal error is generated
298 \&and no old output files are modified and no new output files are opened.
299 \&The result with appending will be the same as from a single run.
300 \&The contents will be binary identical, unless you use a different number
301 \&of nodes or dynamic load balancing or the FFT library uses optimizations
302 \&through timing.
306 \&With option \fB \-maxh\fR a simulation is terminated and a checkpoint
307 \&file is written at the first neighbor search step where the run time
308 \&exceeds \fB \-maxh\fR*0.99 hours.
312 \&When mdrun receives a TERM signal, it will set nsteps to the current
313 \&step plus one. When mdrun receives an INT signal (e.g. when ctrl+C is
314 \&pressed), it will stop after the next neighbor search step 
315 \&(with nstlist=0 at the next step).
316 \&In both cases all the usual output will be written to file.
317 \&When running with MPI, a signal to one of the mdrun processes
318 \&is sufficient, this signal should not be sent to mpirun or
319 \&the mdrun process that is the parent of the others.
323 \&When mdrun is started with MPI, it does not run niced by default.
324 .SH FILES
325 .BI "\-s" " topol.tpr" 
326 .B Input
327  Run input file: tpr tpb tpa 
329 .BI "\-o" " traj.trr" 
330 .B Output
331  Full precision trajectory: trr trj cpt 
333 .BI "\-x" " traj.xtc" 
334 .B Output, Opt.
335  Compressed trajectory (portable xdr format) 
337 .BI "\-cpi" " state.cpt" 
338 .B Input, Opt.
339  Checkpoint file 
341 .BI "\-cpo" " state.cpt" 
342 .B Output, Opt.
343  Checkpoint file 
345 .BI "\-c" " confout.gro" 
346 .B Output
347  Structure file: gro g96 pdb etc. 
349 .BI "\-e" " ener.edr" 
350 .B Output
351  Energy file 
353 .BI "\-g" " md.log" 
354 .B Output
355  Log file 
357 .BI "\-dhdl" " dhdl.xvg" 
358 .B Output, Opt.
359  xvgr/xmgr file 
361 .BI "\-field" " field.xvg" 
362 .B Output, Opt.
363  xvgr/xmgr file 
365 .BI "\-table" " table.xvg" 
366 .B Input, Opt.
367  xvgr/xmgr file 
369 .BI "\-tablep" " tablep.xvg" 
370 .B Input, Opt.
371  xvgr/xmgr file 
373 .BI "\-tableb" " table.xvg" 
374 .B Input, Opt.
375  xvgr/xmgr file 
377 .BI "\-rerun" " rerun.xtc" 
378 .B Input, Opt.
379  Trajectory: xtc trr trj gro g96 pdb cpt 
381 .BI "\-tpi" " tpi.xvg" 
382 .B Output, Opt.
383  xvgr/xmgr file 
385 .BI "\-tpid" " tpidist.xvg" 
386 .B Output, Opt.
387  xvgr/xmgr file 
389 .BI "\-ei" " sam.edi" 
390 .B Input, Opt.
391  ED sampling input 
393 .BI "\-eo" " sam.edo" 
394 .B Output, Opt.
395  ED sampling output 
397 .BI "\-j" " wham.gct" 
398 .B Input, Opt.
399  General coupling stuff 
401 .BI "\-jo" " bam.gct" 
402 .B Output, Opt.
403  General coupling stuff 
405 .BI "\-ffout" " gct.xvg" 
406 .B Output, Opt.
407  xvgr/xmgr file 
409 .BI "\-devout" " deviatie.xvg" 
410 .B Output, Opt.
411  xvgr/xmgr file 
413 .BI "\-runav" " runaver.xvg" 
414 .B Output, Opt.
415  xvgr/xmgr file 
417 .BI "\-px" " pullx.xvg" 
418 .B Output, Opt.
419  xvgr/xmgr file 
421 .BI "\-pf" " pullf.xvg" 
422 .B Output, Opt.
423  xvgr/xmgr file 
425 .BI "\-mtx" " nm.mtx" 
426 .B Output, Opt.
427  Hessian matrix 
429 .BI "\-dn" " dipole.ndx" 
430 .B Output, Opt.
431  Index file 
433 .SH OTHER OPTIONS
434 .BI "\-[no]h"  "no    "
435  Print help info and quit
437 .BI "\-[no]version"  "no    "
438  Print version info and quit
440 .BI "\-nice"  " int" " 0" 
441  Set the nicelevel
443 .BI "\-deffnm"  " string" " " 
444  Set the default filename for all file options
446 .BI "\-xvg"  " enum" " xmgrace" 
447  xvg plot formatting: \fB xmgrace\fR, \fB xmgr\fR or \fB none\fR
449 .BI "\-[no]pd"  "no    "
450  Use particle decompostion
452 .BI "\-dd"  " vector" " 0 0 0" 
453  Domain decomposition grid, 0 is optimize
455 .BI "\-nt"  " int" " 0" 
456  Number of threads to start (0 is guess)
458 .BI "\-npme"  " int" " \-1" 
459  Number of separate nodes to be used for PME, \-1 is guess
461 .BI "\-ddorder"  " enum" " interleave" 
462  DD node order: \fB interleave\fR, \fB pp_pme\fR or \fB cartesian\fR
464 .BI "\-[no]ddcheck"  "yes   "
465  Check for all bonded interactions with DD
467 .BI "\-rdd"  " real" " 0     " 
468  The maximum distance for bonded interactions with DD (nm), 0 is determine from initial coordinates
470 .BI "\-rcon"  " real" " 0     " 
471  Maximum distance for P\-LINCS (nm), 0 is estimate
473 .BI "\-dlb"  " enum" " auto" 
474  Dynamic load balancing (with DD): \fB auto\fR, \fB no\fR or \fB yes\fR
476 .BI "\-dds"  " real" " 0.8   " 
477  Minimum allowed dlb scaling of the DD cell size
479 .BI "\-gcom"  " int" " \-1" 
480  Global communication frequency
482 .BI "\-[no]v"  "no    "
483  Be loud and noisy
485 .BI "\-[no]compact"  "yes   "
486  Write a compact log file
488 .BI "\-[no]seppot"  "no    "
489  Write separate V and dVdl terms for each interaction type and node to the log file(s)
491 .BI "\-pforce"  " real" " \-1    " 
492  Print all forces larger than this (kJ/mol nm)
494 .BI "\-[no]reprod"  "no    "
495  Try to avoid optimizations that affect binary reproducibility
497 .BI "\-cpt"  " real" " 15    " 
498  Checkpoint interval (minutes)
500 .BI "\-[no]cpnum"  "no    "
501  Keep and number checkpoint files
503 .BI "\-[no]append"  "yes   "
504  Append to previous output files when continuing from checkpoint instead of adding the simulation part number to all file names
506 .BI "\-maxh"  " real" " \-1    " 
507  Terminate after 0.99 times this time (hours)
509 .BI "\-multi"  " int" " 0" 
510  Do multiple simulations in parallel
512 .BI "\-replex"  " int" " 0" 
513  Attempt replica exchange every  steps
515 .BI "\-reseed"  " int" " \-1" 
516  Seed for replica exchange, \-1 is generate a seed
518 .BI "\-[no]ionize"  "no    "
519  Do a simulation including the effect of an X\-Ray bombardment on your system
521 .SH SEE ALSO
522 .BR gromacs(7)
524 More information about \fBGROMACS\fR is available at <\fIhttp://www.gromacs.org/\fR>.