Clean up grompp memory leaks in rotation and pull structures.
[gromacs.git] / src / gromacs / gmxpreprocess / readir.cpp
blob489fd216abb7ecc0bc5164d5f660982567d98b38
1 /*
2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
5 * Copyright (c) 2001-2004, The GROMACS development team.
6 * Copyright (c) 2013,2014,2015,2016,2017, The GROMACS development team.
7 * Copyright (c) 2018,2019,2020, by the GROMACS development team, led by
8 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
9 * and including many others, as listed in the AUTHORS file in the
10 * top-level source directory and at http://www.gromacs.org.
12 * GROMACS is free software; you can redistribute it and/or
13 * modify it under the terms of the GNU Lesser General Public License
14 * as published by the Free Software Foundation; either version 2.1
15 * of the License, or (at your option) any later version.
17 * GROMACS is distributed in the hope that it will be useful,
18 * but WITHOUT ANY WARRANTY; without even the implied warranty of
19 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
20 * Lesser General Public License for more details.
22 * You should have received a copy of the GNU Lesser General Public
23 * License along with GROMACS; if not, see
24 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
25 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
27 * If you want to redistribute modifications to GROMACS, please
28 * consider that scientific software is very special. Version
29 * control is crucial - bugs must be traceable. We will be happy to
30 * consider code for inclusion in the official distribution, but
31 * derived work must not be called official GROMACS. Details are found
32 * in the README & COPYING files - if they are missing, get the
33 * official version at http://www.gromacs.org.
35 * To help us fund GROMACS development, we humbly ask that you cite
36 * the research papers on the package. Check out http://www.gromacs.org.
38 #include "gmxpre.h"
40 #include "readir.h"
42 #include <cctype>
43 #include <climits>
44 #include <cmath>
45 #include <cstdlib>
47 #include <algorithm>
48 #include <string>
50 #include "gromacs/awh/read_params.h"
51 #include "gromacs/fileio/readinp.h"
52 #include "gromacs/fileio/warninp.h"
53 #include "gromacs/gmxlib/network.h"
54 #include "gromacs/gmxpreprocess/toputil.h"
55 #include "gromacs/math/functions.h"
56 #include "gromacs/math/units.h"
57 #include "gromacs/math/vec.h"
58 #include "gromacs/mdlib/calc_verletbuf.h"
59 #include "gromacs/mdrun/mdmodules.h"
60 #include "gromacs/mdtypes/inputrec.h"
61 #include "gromacs/mdtypes/md_enums.h"
62 #include "gromacs/mdtypes/pull_params.h"
63 #include "gromacs/options/options.h"
64 #include "gromacs/options/treesupport.h"
65 #include "gromacs/pbcutil/pbc.h"
66 #include "gromacs/selection/indexutil.h"
67 #include "gromacs/topology/block.h"
68 #include "gromacs/topology/ifunc.h"
69 #include "gromacs/topology/index.h"
70 #include "gromacs/topology/mtop_util.h"
71 #include "gromacs/topology/symtab.h"
72 #include "gromacs/topology/topology.h"
73 #include "gromacs/utility/cstringutil.h"
74 #include "gromacs/utility/exceptions.h"
75 #include "gromacs/utility/fatalerror.h"
76 #include "gromacs/utility/filestream.h"
77 #include "gromacs/utility/gmxassert.h"
78 #include "gromacs/utility/ikeyvaluetreeerror.h"
79 #include "gromacs/utility/keyvaluetree.h"
80 #include "gromacs/utility/keyvaluetreebuilder.h"
81 #include "gromacs/utility/keyvaluetreemdpwriter.h"
82 #include "gromacs/utility/keyvaluetreetransform.h"
83 #include "gromacs/utility/mdmodulenotification.h"
84 #include "gromacs/utility/smalloc.h"
85 #include "gromacs/utility/strconvert.h"
86 #include "gromacs/utility/stringcompare.h"
87 #include "gromacs/utility/stringutil.h"
88 #include "gromacs/utility/textwriter.h"
90 #define MAXPTR 254
91 #define NOGID 255
93 /* Resource parameters
94 * Do not change any of these until you read the instruction
95 * in readinp.h. Some cpp's do not take spaces after the backslash
96 * (like the c-shell), which will give you a very weird compiler
97 * message.
100 struct gmx_inputrec_strings
102 char tcgrps[STRLEN], tau_t[STRLEN], ref_t[STRLEN], acc[STRLEN], accgrps[STRLEN], freeze[STRLEN],
103 frdim[STRLEN], energy[STRLEN], user1[STRLEN], user2[STRLEN], vcm[STRLEN],
104 x_compressed_groups[STRLEN], couple_moltype[STRLEN], orirefitgrp[STRLEN],
105 egptable[STRLEN], egpexcl[STRLEN], wall_atomtype[STRLEN], wall_density[STRLEN],
106 deform[STRLEN], QMMM[STRLEN], imd_grp[STRLEN];
107 char fep_lambda[efptNR][STRLEN];
108 char lambda_weights[STRLEN];
109 std::vector<std::string> pullGroupNames;
110 std::vector<std::string> rotateGroupNames;
111 char anneal[STRLEN], anneal_npoints[STRLEN], anneal_time[STRLEN], anneal_temp[STRLEN];
112 char QMmethod[STRLEN], QMbasis[STRLEN], QMcharge[STRLEN], QMmult[STRLEN], bSH[STRLEN],
113 CASorbitals[STRLEN], CASelectrons[STRLEN], SAon[STRLEN], SAoff[STRLEN], SAsteps[STRLEN];
116 static gmx_inputrec_strings* inputrecStrings = nullptr;
118 void init_inputrec_strings()
120 if (inputrecStrings)
122 gmx_incons(
123 "Attempted to call init_inputrec_strings before calling done_inputrec_strings. "
124 "Only one inputrec (i.e. .mdp file) can be parsed at a time.");
126 inputrecStrings = new gmx_inputrec_strings();
129 void done_inputrec_strings()
131 delete inputrecStrings;
132 inputrecStrings = nullptr;
136 enum
138 egrptpALL, /* All particles have to be a member of a group. */
139 egrptpALL_GENREST, /* A rest group with name is generated for particles *
140 * that are not part of any group. */
141 egrptpPART, /* As egrptpALL_GENREST, but no name is generated *
142 * for the rest group. */
143 egrptpONE /* Merge all selected groups into one group, *
144 * make a rest group for the remaining particles. */
147 static const char* constraints[eshNR + 1] = { "none", "h-bonds", "all-bonds",
148 "h-angles", "all-angles", nullptr };
150 static const char* couple_lam[ecouplamNR + 1] = { "vdw-q", "vdw", "q", "none", nullptr };
152 static void GetSimTemps(int ntemps, t_simtemp* simtemp, double* temperature_lambdas)
155 int i;
157 for (i = 0; i < ntemps; i++)
159 /* simple linear scaling -- allows more control */
160 if (simtemp->eSimTempScale == esimtempLINEAR)
162 simtemp->temperatures[i] =
163 simtemp->simtemp_low
164 + (simtemp->simtemp_high - simtemp->simtemp_low) * temperature_lambdas[i];
166 else if (simtemp->eSimTempScale
167 == esimtempGEOMETRIC) /* should give roughly equal acceptance for constant heat capacity . . . */
169 simtemp->temperatures[i] = simtemp->simtemp_low
170 * std::pow(simtemp->simtemp_high / simtemp->simtemp_low,
171 static_cast<real>((1.0 * i) / (ntemps - 1)));
173 else if (simtemp->eSimTempScale == esimtempEXPONENTIAL)
175 simtemp->temperatures[i] = simtemp->simtemp_low
176 + (simtemp->simtemp_high - simtemp->simtemp_low)
177 * (std::expm1(temperature_lambdas[i]) / std::expm1(1.0));
179 else
181 char errorstr[128];
182 sprintf(errorstr, "eSimTempScale=%d not defined", simtemp->eSimTempScale);
183 gmx_fatal(FARGS, "%s", errorstr);
189 static void _low_check(bool b, const char* s, warninp_t wi)
191 if (b)
193 warning_error(wi, s);
197 static void check_nst(const char* desc_nst, int nst, const char* desc_p, int* p, warninp_t wi)
199 char buf[STRLEN];
201 if (*p > 0 && *p % nst != 0)
203 /* Round up to the next multiple of nst */
204 *p = ((*p) / nst + 1) * nst;
205 sprintf(buf, "%s should be a multiple of %s, changing %s to %d\n", desc_p, desc_nst, desc_p, *p);
206 warning(wi, buf);
210 static int lcd(int n1, int n2)
212 int d, i;
214 d = 1;
215 for (i = 2; (i <= n1 && i <= n2); i++)
217 if (n1 % i == 0 && n2 % i == 0)
219 d = i;
223 return d;
226 //! Convert legacy mdp entries to modern ones.
227 static void process_interaction_modifier(int* eintmod)
229 if (*eintmod == eintmodPOTSHIFT_VERLET_UNSUPPORTED)
231 *eintmod = eintmodPOTSHIFT;
235 void check_ir(const char* mdparin,
236 const gmx::MdModulesNotifier& mdModulesNotifier,
237 t_inputrec* ir,
238 t_gromppopts* opts,
239 warninp_t wi)
240 /* Check internal consistency.
241 * NOTE: index groups are not set here yet, don't check things
242 * like temperature coupling group options here, but in triple_check
245 /* Strange macro: first one fills the err_buf, and then one can check
246 * the condition, which will print the message and increase the error
247 * counter.
249 #define CHECK(b) _low_check(b, err_buf, wi)
250 char err_buf[256], warn_buf[STRLEN];
251 int i, j;
252 real dt_pcoupl;
253 t_lambda* fep = ir->fepvals;
254 t_expanded* expand = ir->expandedvals;
256 set_warning_line(wi, mdparin, -1);
258 if (ir->coulombtype == eelRF_NEC_UNSUPPORTED)
260 sprintf(warn_buf, "%s electrostatics is no longer supported", eel_names[eelRF_NEC_UNSUPPORTED]);
261 warning_error(wi, warn_buf);
264 /* BASIC CUT-OFF STUFF */
265 if (ir->rcoulomb < 0)
267 warning_error(wi, "rcoulomb should be >= 0");
269 if (ir->rvdw < 0)
271 warning_error(wi, "rvdw should be >= 0");
273 if (ir->rlist < 0 && !(ir->cutoff_scheme == ecutsVERLET && ir->verletbuf_tol > 0))
275 warning_error(wi, "rlist should be >= 0");
277 sprintf(err_buf,
278 "nstlist can not be smaller than 0. (If you were trying to use the heuristic "
279 "neighbour-list update scheme for efficient buffering for improved energy "
280 "conservation, please use the Verlet cut-off scheme instead.)");
281 CHECK(ir->nstlist < 0);
283 process_interaction_modifier(&ir->coulomb_modifier);
284 process_interaction_modifier(&ir->vdw_modifier);
286 if (ir->cutoff_scheme == ecutsGROUP)
288 gmx_fatal(FARGS,
289 "The group cutoff scheme has been removed since GROMACS 2020. "
290 "Please use the Verlet cutoff scheme.");
292 if (ir->cutoff_scheme == ecutsVERLET)
294 real rc_max;
296 /* Normal Verlet type neighbor-list, currently only limited feature support */
297 if (inputrec2nboundeddim(ir) < 3)
299 warning_error(wi, "With Verlet lists only full pbc or pbc=xy with walls is supported");
302 // We don't (yet) have general Verlet kernels for rcoulomb!=rvdw
303 if (ir->rcoulomb != ir->rvdw)
305 // Since we have PME coulomb + LJ cut-off kernels with rcoulomb>rvdw
306 // for PME load balancing, we can support this exception.
307 bool bUsesPmeTwinRangeKernel = (EEL_PME_EWALD(ir->coulombtype) && ir->vdwtype == evdwCUT
308 && ir->rcoulomb > ir->rvdw);
309 if (!bUsesPmeTwinRangeKernel)
311 warning_error(wi,
312 "With Verlet lists rcoulomb!=rvdw is not supported (except for "
313 "rcoulomb>rvdw with PME electrostatics)");
317 if (ir->vdwtype == evdwSHIFT || ir->vdwtype == evdwSWITCH)
319 if (ir->vdw_modifier == eintmodNONE || ir->vdw_modifier == eintmodPOTSHIFT)
321 ir->vdw_modifier = (ir->vdwtype == evdwSHIFT ? eintmodFORCESWITCH : eintmodPOTSWITCH);
323 sprintf(warn_buf,
324 "Replacing vdwtype=%s by the equivalent combination of vdwtype=%s and "
325 "vdw_modifier=%s",
326 evdw_names[ir->vdwtype], evdw_names[evdwCUT], eintmod_names[ir->vdw_modifier]);
327 warning_note(wi, warn_buf);
329 ir->vdwtype = evdwCUT;
331 else
333 sprintf(warn_buf, "Unsupported combination of vdwtype=%s and vdw_modifier=%s",
334 evdw_names[ir->vdwtype], eintmod_names[ir->vdw_modifier]);
335 warning_error(wi, warn_buf);
339 if (!(ir->vdwtype == evdwCUT || ir->vdwtype == evdwPME))
341 warning_error(wi,
342 "With Verlet lists only cut-off and PME LJ interactions are supported");
344 if (!(ir->coulombtype == eelCUT || EEL_RF(ir->coulombtype) || EEL_PME(ir->coulombtype)
345 || ir->coulombtype == eelEWALD))
347 warning_error(wi,
348 "With Verlet lists only cut-off, reaction-field, PME and Ewald "
349 "electrostatics are supported");
351 if (!(ir->coulomb_modifier == eintmodNONE || ir->coulomb_modifier == eintmodPOTSHIFT))
353 sprintf(warn_buf, "coulomb_modifier=%s is not supported", eintmod_names[ir->coulomb_modifier]);
354 warning_error(wi, warn_buf);
357 if (EEL_USER(ir->coulombtype))
359 sprintf(warn_buf, "Coulomb type %s is not supported with the verlet scheme",
360 eel_names[ir->coulombtype]);
361 warning_error(wi, warn_buf);
364 if (ir->nstlist <= 0)
366 warning_error(wi, "With Verlet lists nstlist should be larger than 0");
369 if (ir->nstlist < 10)
371 warning_note(wi,
372 "With Verlet lists the optimal nstlist is >= 10, with GPUs >= 20. Note "
373 "that with the Verlet scheme, nstlist has no effect on the accuracy of "
374 "your simulation.");
377 rc_max = std::max(ir->rvdw, ir->rcoulomb);
379 if (EI_TPI(ir->eI))
381 /* With TPI we set the pairlist cut-off later using the radius of the insterted molecule */
382 ir->verletbuf_tol = 0;
383 ir->rlist = rc_max;
385 else if (ir->verletbuf_tol <= 0)
387 if (ir->verletbuf_tol == 0)
389 warning_error(wi, "Can not have Verlet buffer tolerance of exactly 0");
392 if (ir->rlist < rc_max)
394 warning_error(wi,
395 "With verlet lists rlist can not be smaller than rvdw or rcoulomb");
398 if (ir->rlist == rc_max && ir->nstlist > 1)
400 warning_note(
402 "rlist is equal to rvdw and/or rcoulomb: there is no explicit Verlet "
403 "buffer. The cluster pair list does have a buffering effect, but choosing "
404 "a larger rlist might be necessary for good energy conservation.");
407 else
409 if (ir->rlist > rc_max)
411 warning_note(wi,
412 "You have set rlist larger than the interaction cut-off, but you also "
413 "have verlet-buffer-tolerance > 0. Will set rlist using "
414 "verlet-buffer-tolerance.");
417 if (ir->nstlist == 1)
419 /* No buffer required */
420 ir->rlist = rc_max;
422 else
424 if (EI_DYNAMICS(ir->eI))
426 if (inputrec2nboundeddim(ir) < 3)
428 warning_error(wi,
429 "The box volume is required for calculating rlist from the "
430 "energy drift with verlet-buffer-tolerance > 0. You are "
431 "using at least one unbounded dimension, so no volume can be "
432 "computed. Either use a finite box, or set rlist yourself "
433 "together with verlet-buffer-tolerance = -1.");
435 /* Set rlist temporarily so we can continue processing */
436 ir->rlist = rc_max;
438 else
440 /* Set the buffer to 5% of the cut-off */
441 ir->rlist = (1.0 + verlet_buffer_ratio_nodynamics) * rc_max;
447 /* GENERAL INTEGRATOR STUFF */
448 if (!EI_MD(ir->eI))
450 if (ir->etc != etcNO)
452 if (EI_RANDOM(ir->eI))
454 sprintf(warn_buf,
455 "Setting tcoupl from '%s' to 'no'. %s handles temperature coupling "
456 "implicitly. See the documentation for more information on which "
457 "parameters affect temperature for %s.",
458 etcoupl_names[ir->etc], ei_names[ir->eI], ei_names[ir->eI]);
460 else
462 sprintf(warn_buf,
463 "Setting tcoupl from '%s' to 'no'. Temperature coupling does not apply to "
464 "%s.",
465 etcoupl_names[ir->etc], ei_names[ir->eI]);
467 warning_note(wi, warn_buf);
469 ir->etc = etcNO;
471 if (ir->eI == eiVVAK)
473 sprintf(warn_buf,
474 "Integrator method %s is implemented primarily for validation purposes; for "
475 "molecular dynamics, you should probably be using %s or %s",
476 ei_names[eiVVAK], ei_names[eiMD], ei_names[eiVV]);
477 warning_note(wi, warn_buf);
479 if (!EI_DYNAMICS(ir->eI))
481 if (ir->epc != epcNO)
483 sprintf(warn_buf,
484 "Setting pcoupl from '%s' to 'no'. Pressure coupling does not apply to %s.",
485 epcoupl_names[ir->epc], ei_names[ir->eI]);
486 warning_note(wi, warn_buf);
488 ir->epc = epcNO;
490 if (EI_DYNAMICS(ir->eI))
492 if (ir->nstcalcenergy < 0)
494 ir->nstcalcenergy = ir_optimal_nstcalcenergy(ir);
495 if (ir->nstenergy != 0 && ir->nstenergy < ir->nstcalcenergy)
497 /* nstcalcenergy larger than nstener does not make sense.
498 * We ideally want nstcalcenergy=nstener.
500 if (ir->nstlist > 0)
502 ir->nstcalcenergy = lcd(ir->nstenergy, ir->nstlist);
504 else
506 ir->nstcalcenergy = ir->nstenergy;
510 else if ((ir->nstenergy > 0 && ir->nstcalcenergy > ir->nstenergy)
511 || (ir->efep != efepNO && ir->fepvals->nstdhdl > 0
512 && (ir->nstcalcenergy > ir->fepvals->nstdhdl)))
515 const char* nsten = "nstenergy";
516 const char* nstdh = "nstdhdl";
517 const char* min_name = nsten;
518 int min_nst = ir->nstenergy;
520 /* find the smallest of ( nstenergy, nstdhdl ) */
521 if (ir->efep != efepNO && ir->fepvals->nstdhdl > 0
522 && (ir->nstenergy == 0 || ir->fepvals->nstdhdl < ir->nstenergy))
524 min_nst = ir->fepvals->nstdhdl;
525 min_name = nstdh;
527 /* If the user sets nstenergy small, we should respect that */
528 sprintf(warn_buf, "Setting nstcalcenergy (%d) equal to %s (%d)", ir->nstcalcenergy,
529 min_name, min_nst);
530 warning_note(wi, warn_buf);
531 ir->nstcalcenergy = min_nst;
534 if (ir->epc != epcNO)
536 if (ir->nstpcouple < 0)
538 ir->nstpcouple = ir_optimal_nstpcouple(ir);
542 if (ir->nstcalcenergy > 0)
544 if (ir->efep != efepNO)
546 /* nstdhdl should be a multiple of nstcalcenergy */
547 check_nst("nstcalcenergy", ir->nstcalcenergy, "nstdhdl", &ir->fepvals->nstdhdl, wi);
549 if (ir->bExpanded)
551 /* nstexpanded should be a multiple of nstcalcenergy */
552 check_nst("nstcalcenergy", ir->nstcalcenergy, "nstexpanded",
553 &ir->expandedvals->nstexpanded, wi);
555 /* for storing exact averages nstenergy should be
556 * a multiple of nstcalcenergy
558 check_nst("nstcalcenergy", ir->nstcalcenergy, "nstenergy", &ir->nstenergy, wi);
561 // Inquire all MdModules, if their parameters match with the energy
562 // calculation frequency
563 gmx::EnergyCalculationFrequencyErrors energyCalculationFrequencyErrors(ir->nstcalcenergy);
564 mdModulesNotifier.preProcessingNotifications_.notify(&energyCalculationFrequencyErrors);
566 // Emit all errors from the energy calculation frequency checks
567 for (const std::string& energyFrequencyErrorMessage :
568 energyCalculationFrequencyErrors.errorMessages())
570 warning_error(wi, energyFrequencyErrorMessage);
574 if (ir->nsteps == 0 && !ir->bContinuation)
576 warning_note(wi,
577 "For a correct single-point energy evaluation with nsteps = 0, use "
578 "continuation = yes to avoid constraining the input coordinates.");
581 /* LD STUFF */
582 if ((EI_SD(ir->eI) || ir->eI == eiBD) && ir->bContinuation && ir->ld_seed != -1)
584 warning_note(wi,
585 "You are doing a continuation with SD or BD, make sure that ld_seed is "
586 "different from the previous run (using ld_seed=-1 will ensure this)");
589 /* TPI STUFF */
590 if (EI_TPI(ir->eI))
592 sprintf(err_buf, "TPI only works with pbc = %s", c_pbcTypeNames[PbcType::Xyz].c_str());
593 CHECK(ir->pbcType != PbcType::Xyz);
594 sprintf(err_buf, "with TPI nstlist should be larger than zero");
595 CHECK(ir->nstlist <= 0);
596 sprintf(err_buf, "TPI does not work with full electrostatics other than PME");
597 CHECK(EEL_FULL(ir->coulombtype) && !EEL_PME(ir->coulombtype));
600 /* SHAKE / LINCS */
601 if ((opts->nshake > 0) && (opts->bMorse))
603 sprintf(warn_buf, "Using morse bond-potentials while constraining bonds is useless");
604 warning(wi, warn_buf);
607 if ((EI_SD(ir->eI) || ir->eI == eiBD) && ir->bContinuation && ir->ld_seed != -1)
609 warning_note(wi,
610 "You are doing a continuation with SD or BD, make sure that ld_seed is "
611 "different from the previous run (using ld_seed=-1 will ensure this)");
613 /* verify simulated tempering options */
615 if (ir->bSimTemp)
617 bool bAllTempZero = TRUE;
618 for (i = 0; i < fep->n_lambda; i++)
620 sprintf(err_buf, "Entry %d for %s must be between 0 and 1, instead is %g", i,
621 efpt_names[efptTEMPERATURE], fep->all_lambda[efptTEMPERATURE][i]);
622 CHECK((fep->all_lambda[efptTEMPERATURE][i] < 0) || (fep->all_lambda[efptTEMPERATURE][i] > 1));
623 if (fep->all_lambda[efptTEMPERATURE][i] > 0)
625 bAllTempZero = FALSE;
628 sprintf(err_buf, "if simulated tempering is on, temperature-lambdas may not be all zero");
629 CHECK(bAllTempZero == TRUE);
631 sprintf(err_buf, "Simulated tempering is currently only compatible with md-vv");
632 CHECK(ir->eI != eiVV);
634 /* check compatability of the temperature coupling with simulated tempering */
636 if (ir->etc == etcNOSEHOOVER)
638 sprintf(warn_buf,
639 "Nose-Hoover based temperature control such as [%s] my not be "
640 "entirelyconsistent with simulated tempering",
641 etcoupl_names[ir->etc]);
642 warning_note(wi, warn_buf);
645 /* check that the temperatures make sense */
647 sprintf(err_buf,
648 "Higher simulated tempering temperature (%g) must be >= than the simulated "
649 "tempering lower temperature (%g)",
650 ir->simtempvals->simtemp_high, ir->simtempvals->simtemp_low);
651 CHECK(ir->simtempvals->simtemp_high <= ir->simtempvals->simtemp_low);
653 sprintf(err_buf, "Higher simulated tempering temperature (%g) must be >= zero",
654 ir->simtempvals->simtemp_high);
655 CHECK(ir->simtempvals->simtemp_high <= 0);
657 sprintf(err_buf, "Lower simulated tempering temperature (%g) must be >= zero",
658 ir->simtempvals->simtemp_low);
659 CHECK(ir->simtempvals->simtemp_low <= 0);
662 /* verify free energy options */
664 if (ir->efep != efepNO)
666 fep = ir->fepvals;
667 sprintf(err_buf, "The soft-core power is %d and can only be 1 or 2", fep->sc_power);
668 CHECK(fep->sc_alpha != 0 && fep->sc_power != 1 && fep->sc_power != 2);
670 sprintf(err_buf,
671 "The soft-core sc-r-power is %d and can only be 6. (sc-r-power 48 is no longer "
672 "supported.)",
673 static_cast<int>(fep->sc_r_power));
674 CHECK(fep->sc_alpha != 0 && fep->sc_r_power != 6.0);
676 sprintf(err_buf,
677 "Can't use positive delta-lambda (%g) if initial state/lambda does not start at "
678 "zero",
679 fep->delta_lambda);
680 CHECK(fep->delta_lambda > 0 && ((fep->init_fep_state > 0) || (fep->init_lambda > 0)));
682 sprintf(err_buf, "Can't use positive delta-lambda (%g) with expanded ensemble simulations",
683 fep->delta_lambda);
684 CHECK(fep->delta_lambda > 0 && (ir->efep == efepEXPANDED));
686 sprintf(err_buf, "Can only use expanded ensemble with md-vv (for now)");
687 CHECK(!(EI_VV(ir->eI)) && (ir->efep == efepEXPANDED));
689 sprintf(err_buf, "Free-energy not implemented for Ewald");
690 CHECK(ir->coulombtype == eelEWALD);
692 /* check validty of lambda inputs */
693 if (fep->n_lambda == 0)
695 /* Clear output in case of no states:*/
696 sprintf(err_buf, "init-lambda-state set to %d: no lambda states are defined.",
697 fep->init_fep_state);
698 CHECK((fep->init_fep_state >= 0) && (fep->n_lambda == 0));
700 else
702 sprintf(err_buf, "initial thermodynamic state %d does not exist, only goes to %d",
703 fep->init_fep_state, fep->n_lambda - 1);
704 CHECK((fep->init_fep_state >= fep->n_lambda));
707 sprintf(err_buf,
708 "Lambda state must be set, either with init-lambda-state or with init-lambda");
709 CHECK((fep->init_fep_state < 0) && (fep->init_lambda < 0));
711 sprintf(err_buf,
712 "init-lambda=%g while init-lambda-state=%d. Lambda state must be set either with "
713 "init-lambda-state or with init-lambda, but not both",
714 fep->init_lambda, fep->init_fep_state);
715 CHECK((fep->init_fep_state >= 0) && (fep->init_lambda >= 0));
718 if ((fep->init_lambda >= 0) && (fep->delta_lambda == 0))
720 int n_lambda_terms;
721 n_lambda_terms = 0;
722 for (i = 0; i < efptNR; i++)
724 if (fep->separate_dvdl[i])
726 n_lambda_terms++;
729 if (n_lambda_terms > 1)
731 sprintf(warn_buf,
732 "If lambda vector states (fep-lambdas, coul-lambdas etc.) are set, don't "
733 "use init-lambda to set lambda state (except for slow growth). Use "
734 "init-lambda-state instead.");
735 warning(wi, warn_buf);
738 if (n_lambda_terms < 2 && fep->n_lambda > 0)
740 warning_note(wi,
741 "init-lambda is deprecated for setting lambda state (except for slow "
742 "growth). Use init-lambda-state instead.");
746 for (j = 0; j < efptNR; j++)
748 for (i = 0; i < fep->n_lambda; i++)
750 sprintf(err_buf, "Entry %d for %s must be between 0 and 1, instead is %g", i,
751 efpt_names[j], fep->all_lambda[j][i]);
752 CHECK((fep->all_lambda[j][i] < 0) || (fep->all_lambda[j][i] > 1));
756 if ((fep->sc_alpha > 0) && (!fep->bScCoul))
758 for (i = 0; i < fep->n_lambda; i++)
760 sprintf(err_buf,
761 "For state %d, vdw-lambdas (%f) is changing with vdw softcore, while "
762 "coul-lambdas (%f) is nonzero without coulomb softcore: this will lead to "
763 "crashes, and is not supported.",
764 i, fep->all_lambda[efptVDW][i], fep->all_lambda[efptCOUL][i]);
765 CHECK((fep->sc_alpha > 0)
766 && (((fep->all_lambda[efptCOUL][i] > 0.0) && (fep->all_lambda[efptCOUL][i] < 1.0))
767 && ((fep->all_lambda[efptVDW][i] > 0.0) && (fep->all_lambda[efptVDW][i] < 1.0))));
771 if ((fep->bScCoul) && (EEL_PME(ir->coulombtype)))
773 real sigma, lambda, r_sc;
775 sigma = 0.34;
776 /* Maximum estimate for A and B charges equal with lambda power 1 */
777 lambda = 0.5;
778 r_sc = std::pow(lambda * fep->sc_alpha * std::pow(sigma / ir->rcoulomb, fep->sc_r_power) + 1.0,
779 1.0 / fep->sc_r_power);
780 sprintf(warn_buf,
781 "With PME there is a minor soft core effect present at the cut-off, "
782 "proportional to (LJsigma/rcoulomb)^%g. This could have a minor effect on "
783 "energy conservation, but usually other effects dominate. With a common sigma "
784 "value of %g nm the fraction of the particle-particle potential at the cut-off "
785 "at lambda=%g is around %.1e, while ewald-rtol is %.1e.",
786 fep->sc_r_power, sigma, lambda, r_sc - 1.0, ir->ewald_rtol);
787 warning_note(wi, warn_buf);
790 /* Free Energy Checks -- In an ideal world, slow growth and FEP would
791 be treated differently, but that's the next step */
793 for (i = 0; i < efptNR; i++)
795 for (j = 0; j < fep->n_lambda; j++)
797 sprintf(err_buf, "%s[%d] must be between 0 and 1", efpt_names[i], j);
798 CHECK((fep->all_lambda[i][j] < 0) || (fep->all_lambda[i][j] > 1));
803 if ((ir->bSimTemp) || (ir->efep == efepEXPANDED))
805 fep = ir->fepvals;
807 /* checking equilibration of weights inputs for validity */
809 sprintf(err_buf,
810 "weight-equil-number-all-lambda (%d) is ignored if lmc-weights-equil is not equal "
811 "to %s",
812 expand->equil_n_at_lam, elmceq_names[elmceqNUMATLAM]);
813 CHECK((expand->equil_n_at_lam > 0) && (expand->elmceq != elmceqNUMATLAM));
815 sprintf(err_buf,
816 "weight-equil-number-samples (%d) is ignored if lmc-weights-equil is not equal to "
817 "%s",
818 expand->equil_samples, elmceq_names[elmceqSAMPLES]);
819 CHECK((expand->equil_samples > 0) && (expand->elmceq != elmceqSAMPLES));
821 sprintf(err_buf,
822 "weight-equil-number-steps (%d) is ignored if lmc-weights-equil is not equal to %s",
823 expand->equil_steps, elmceq_names[elmceqSTEPS]);
824 CHECK((expand->equil_steps > 0) && (expand->elmceq != elmceqSTEPS));
826 sprintf(err_buf,
827 "weight-equil-wl-delta (%d) is ignored if lmc-weights-equil is not equal to %s",
828 expand->equil_samples, elmceq_names[elmceqWLDELTA]);
829 CHECK((expand->equil_wl_delta > 0) && (expand->elmceq != elmceqWLDELTA));
831 sprintf(err_buf,
832 "weight-equil-count-ratio (%f) is ignored if lmc-weights-equil is not equal to %s",
833 expand->equil_ratio, elmceq_names[elmceqRATIO]);
834 CHECK((expand->equil_ratio > 0) && (expand->elmceq != elmceqRATIO));
836 sprintf(err_buf,
837 "weight-equil-number-all-lambda (%d) must be a positive integer if "
838 "lmc-weights-equil=%s",
839 expand->equil_n_at_lam, elmceq_names[elmceqNUMATLAM]);
840 CHECK((expand->equil_n_at_lam <= 0) && (expand->elmceq == elmceqNUMATLAM));
842 sprintf(err_buf,
843 "weight-equil-number-samples (%d) must be a positive integer if "
844 "lmc-weights-equil=%s",
845 expand->equil_samples, elmceq_names[elmceqSAMPLES]);
846 CHECK((expand->equil_samples <= 0) && (expand->elmceq == elmceqSAMPLES));
848 sprintf(err_buf,
849 "weight-equil-number-steps (%d) must be a positive integer if lmc-weights-equil=%s",
850 expand->equil_steps, elmceq_names[elmceqSTEPS]);
851 CHECK((expand->equil_steps <= 0) && (expand->elmceq == elmceqSTEPS));
853 sprintf(err_buf, "weight-equil-wl-delta (%f) must be > 0 if lmc-weights-equil=%s",
854 expand->equil_wl_delta, elmceq_names[elmceqWLDELTA]);
855 CHECK((expand->equil_wl_delta <= 0) && (expand->elmceq == elmceqWLDELTA));
857 sprintf(err_buf, "weight-equil-count-ratio (%f) must be > 0 if lmc-weights-equil=%s",
858 expand->equil_ratio, elmceq_names[elmceqRATIO]);
859 CHECK((expand->equil_ratio <= 0) && (expand->elmceq == elmceqRATIO));
861 sprintf(err_buf, "lmc-weights-equil=%s only possible when lmc-stats = %s or lmc-stats %s",
862 elmceq_names[elmceqWLDELTA], elamstats_names[elamstatsWL], elamstats_names[elamstatsWWL]);
863 CHECK((expand->elmceq == elmceqWLDELTA) && (!EWL(expand->elamstats)));
865 sprintf(err_buf, "lmc-repeats (%d) must be greater than 0", expand->lmc_repeats);
866 CHECK((expand->lmc_repeats <= 0));
867 sprintf(err_buf, "minimum-var-min (%d) must be greater than 0", expand->minvarmin);
868 CHECK((expand->minvarmin <= 0));
869 sprintf(err_buf, "weight-c-range (%d) must be greater or equal to 0", expand->c_range);
870 CHECK((expand->c_range < 0));
871 sprintf(err_buf,
872 "init-lambda-state (%d) must be zero if lmc-forced-nstart (%d)> 0 and lmc-move != "
873 "'no'",
874 fep->init_fep_state, expand->lmc_forced_nstart);
875 CHECK((fep->init_fep_state != 0) && (expand->lmc_forced_nstart > 0)
876 && (expand->elmcmove != elmcmoveNO));
877 sprintf(err_buf, "lmc-forced-nstart (%d) must not be negative", expand->lmc_forced_nstart);
878 CHECK((expand->lmc_forced_nstart < 0));
879 sprintf(err_buf, "init-lambda-state (%d) must be in the interval [0,number of lambdas)",
880 fep->init_fep_state);
881 CHECK((fep->init_fep_state < 0) || (fep->init_fep_state >= fep->n_lambda));
883 sprintf(err_buf, "init-wl-delta (%f) must be greater than or equal to 0", expand->init_wl_delta);
884 CHECK((expand->init_wl_delta < 0));
885 sprintf(err_buf, "wl-ratio (%f) must be between 0 and 1", expand->wl_ratio);
886 CHECK((expand->wl_ratio <= 0) || (expand->wl_ratio >= 1));
887 sprintf(err_buf, "wl-scale (%f) must be between 0 and 1", expand->wl_scale);
888 CHECK((expand->wl_scale <= 0) || (expand->wl_scale >= 1));
890 /* if there is no temperature control, we need to specify an MC temperature */
891 if (!integratorHasReferenceTemperature(ir) && (expand->elmcmove != elmcmoveNO)
892 && (expand->mc_temp <= 0.0))
894 sprintf(err_buf,
895 "If there is no temperature control, and lmc-mcmove!='no', mc_temp must be set "
896 "to a positive number");
897 warning_error(wi, err_buf);
899 if (expand->nstTij > 0)
901 sprintf(err_buf, "nstlog must be non-zero");
902 CHECK(ir->nstlog == 0);
903 // Avoid modulus by zero in the case that already triggered an error exit.
904 if (ir->nstlog != 0)
906 sprintf(err_buf,
907 "nst-transition-matrix (%d) must be an integer multiple of nstlog (%d)",
908 expand->nstTij, ir->nstlog);
909 CHECK((expand->nstTij % ir->nstlog) != 0);
914 /* PBC/WALLS */
915 sprintf(err_buf, "walls only work with pbc=%s", c_pbcTypeNames[PbcType::XY].c_str());
916 CHECK(ir->nwall && ir->pbcType != PbcType::XY);
918 /* VACUUM STUFF */
919 if (ir->pbcType != PbcType::Xyz && ir->nwall != 2)
921 if (ir->pbcType == PbcType::No)
923 if (ir->epc != epcNO)
925 warning(wi, "Turning off pressure coupling for vacuum system");
926 ir->epc = epcNO;
929 else
931 sprintf(err_buf, "Can not have pressure coupling with pbc=%s",
932 c_pbcTypeNames[ir->pbcType].c_str());
933 CHECK(ir->epc != epcNO);
935 sprintf(err_buf, "Can not have Ewald with pbc=%s", c_pbcTypeNames[ir->pbcType].c_str());
936 CHECK(EEL_FULL(ir->coulombtype));
938 sprintf(err_buf, "Can not have dispersion correction with pbc=%s",
939 c_pbcTypeNames[ir->pbcType].c_str());
940 CHECK(ir->eDispCorr != edispcNO);
943 if (ir->rlist == 0.0)
945 sprintf(err_buf,
946 "can only have neighborlist cut-off zero (=infinite)\n"
947 "with coulombtype = %s or coulombtype = %s\n"
948 "without periodic boundary conditions (pbc = %s) and\n"
949 "rcoulomb and rvdw set to zero",
950 eel_names[eelCUT], eel_names[eelUSER], c_pbcTypeNames[PbcType::No].c_str());
951 CHECK(((ir->coulombtype != eelCUT) && (ir->coulombtype != eelUSER))
952 || (ir->pbcType != PbcType::No) || (ir->rcoulomb != 0.0) || (ir->rvdw != 0.0));
954 if (ir->nstlist > 0)
956 warning_note(wi,
957 "Simulating without cut-offs can be (slightly) faster with nstlist=0, "
958 "nstype=simple and only one MPI rank");
962 /* COMM STUFF */
963 if (ir->nstcomm == 0)
965 // TODO Change this behaviour. There should be exactly one way
966 // to turn off an algorithm.
967 ir->comm_mode = ecmNO;
969 if (ir->comm_mode != ecmNO)
971 if (ir->nstcomm < 0)
973 // TODO Such input was once valid. Now that we've been
974 // helpful for a few years, we should reject such input,
975 // lest we have to support every historical decision
976 // forever.
977 warning(wi,
978 "If you want to remove the rotation around the center of mass, you should set "
979 "comm_mode = Angular instead of setting nstcomm < 0. nstcomm is modified to "
980 "its absolute value");
981 ir->nstcomm = abs(ir->nstcomm);
984 if (ir->nstcalcenergy > 0 && ir->nstcomm < ir->nstcalcenergy)
986 warning_note(wi,
987 "nstcomm < nstcalcenergy defeats the purpose of nstcalcenergy, setting "
988 "nstcomm to nstcalcenergy");
989 ir->nstcomm = ir->nstcalcenergy;
992 if (ir->comm_mode == ecmANGULAR)
994 sprintf(err_buf,
995 "Can not remove the rotation around the center of mass with periodic "
996 "molecules");
997 CHECK(ir->bPeriodicMols);
998 if (ir->pbcType != PbcType::No)
1000 warning(wi,
1001 "Removing the rotation around the center of mass in a periodic system, "
1002 "this can lead to artifacts. Only use this on a single (cluster of) "
1003 "molecules. This cluster should not cross periodic boundaries.");
1008 if (EI_STATE_VELOCITY(ir->eI) && !EI_SD(ir->eI) && ir->pbcType == PbcType::No && ir->comm_mode != ecmANGULAR)
1010 sprintf(warn_buf,
1011 "Tumbling and flying ice-cubes: We are not removing rotation around center of mass "
1012 "in a non-periodic system. You should probably set comm_mode = ANGULAR or use "
1013 "integrator = %s.",
1014 ei_names[eiSD1]);
1015 warning_note(wi, warn_buf);
1018 /* TEMPERATURE COUPLING */
1019 if (ir->etc == etcYES)
1021 ir->etc = etcBERENDSEN;
1022 warning_note(wi,
1023 "Old option for temperature coupling given: "
1024 "changing \"yes\" to \"Berendsen\"\n");
1027 if ((ir->etc == etcNOSEHOOVER) || (ir->epc == epcMTTK))
1029 if (ir->opts.nhchainlength < 1)
1031 sprintf(warn_buf,
1032 "number of Nose-Hoover chains (currently %d) cannot be less than 1,reset to "
1033 "1\n",
1034 ir->opts.nhchainlength);
1035 ir->opts.nhchainlength = 1;
1036 warning(wi, warn_buf);
1039 if (ir->etc == etcNOSEHOOVER && !EI_VV(ir->eI) && ir->opts.nhchainlength > 1)
1041 warning_note(
1043 "leapfrog does not yet support Nose-Hoover chains, nhchainlength reset to 1");
1044 ir->opts.nhchainlength = 1;
1047 else
1049 ir->opts.nhchainlength = 0;
1052 if (ir->eI == eiVVAK)
1054 sprintf(err_buf,
1055 "%s implemented primarily for validation, and requires nsttcouple = 1 and "
1056 "nstpcouple = 1.",
1057 ei_names[eiVVAK]);
1058 CHECK((ir->nsttcouple != 1) || (ir->nstpcouple != 1));
1061 if (ETC_ANDERSEN(ir->etc))
1063 sprintf(err_buf, "%s temperature control not supported for integrator %s.",
1064 etcoupl_names[ir->etc], ei_names[ir->eI]);
1065 CHECK(!(EI_VV(ir->eI)));
1067 if (ir->nstcomm > 0 && (ir->etc == etcANDERSEN))
1069 sprintf(warn_buf,
1070 "Center of mass removal not necessary for %s. All velocities of coupled "
1071 "groups are rerandomized periodically, so flying ice cube errors will not "
1072 "occur.",
1073 etcoupl_names[ir->etc]);
1074 warning_note(wi, warn_buf);
1077 sprintf(err_buf,
1078 "nstcomm must be 1, not %d for %s, as velocities of atoms in coupled groups are "
1079 "randomized every time step",
1080 ir->nstcomm, etcoupl_names[ir->etc]);
1081 CHECK(ir->nstcomm > 1 && (ir->etc == etcANDERSEN));
1084 if (ir->etc == etcBERENDSEN)
1086 sprintf(warn_buf,
1087 "The %s thermostat does not generate the correct kinetic energy distribution. You "
1088 "might want to consider using the %s thermostat.",
1089 ETCOUPLTYPE(ir->etc), ETCOUPLTYPE(etcVRESCALE));
1090 warning_note(wi, warn_buf);
1093 if ((ir->etc == etcNOSEHOOVER || ETC_ANDERSEN(ir->etc)) && ir->epc == epcBERENDSEN)
1095 sprintf(warn_buf,
1096 "Using Berendsen pressure coupling invalidates the "
1097 "true ensemble for the thermostat");
1098 warning(wi, warn_buf);
1101 /* PRESSURE COUPLING */
1102 if (ir->epc == epcISOTROPIC)
1104 ir->epc = epcBERENDSEN;
1105 warning_note(wi,
1106 "Old option for pressure coupling given: "
1107 "changing \"Isotropic\" to \"Berendsen\"\n");
1110 if (ir->epc != epcNO)
1112 dt_pcoupl = ir->nstpcouple * ir->delta_t;
1114 sprintf(err_buf, "tau-p must be > 0 instead of %g\n", ir->tau_p);
1115 CHECK(ir->tau_p <= 0);
1117 if (ir->tau_p / dt_pcoupl < pcouple_min_integration_steps(ir->epc) - 10 * GMX_REAL_EPS)
1119 sprintf(warn_buf,
1120 "For proper integration of the %s barostat, tau-p (%g) should be at least %d "
1121 "times larger than nstpcouple*dt (%g)",
1122 EPCOUPLTYPE(ir->epc), ir->tau_p, pcouple_min_integration_steps(ir->epc), dt_pcoupl);
1123 warning(wi, warn_buf);
1126 sprintf(err_buf,
1127 "compressibility must be > 0 when using pressure"
1128 " coupling %s\n",
1129 EPCOUPLTYPE(ir->epc));
1130 CHECK(ir->compress[XX][XX] < 0 || ir->compress[YY][YY] < 0 || ir->compress[ZZ][ZZ] < 0
1131 || (trace(ir->compress) == 0 && ir->compress[YY][XX] <= 0 && ir->compress[ZZ][XX] <= 0
1132 && ir->compress[ZZ][YY] <= 0));
1134 if (epcPARRINELLORAHMAN == ir->epc && opts->bGenVel)
1136 sprintf(warn_buf,
1137 "You are generating velocities so I am assuming you "
1138 "are equilibrating a system. You are using "
1139 "%s pressure coupling, but this can be "
1140 "unstable for equilibration. If your system crashes, try "
1141 "equilibrating first with Berendsen pressure coupling. If "
1142 "you are not equilibrating the system, you can probably "
1143 "ignore this warning.",
1144 epcoupl_names[ir->epc]);
1145 warning(wi, warn_buf);
1149 if (!EI_VV(ir->eI))
1151 if (ir->epc == epcMTTK)
1153 warning_error(wi, "MTTK pressure coupling requires a Velocity-verlet integrator");
1157 /* ELECTROSTATICS */
1158 /* More checks are in triple check (grompp.c) */
1160 if (ir->coulombtype == eelSWITCH)
1162 sprintf(warn_buf,
1163 "coulombtype = %s is only for testing purposes and can lead to serious "
1164 "artifacts, advice: use coulombtype = %s",
1165 eel_names[ir->coulombtype], eel_names[eelRF_ZERO]);
1166 warning(wi, warn_buf);
1169 if (EEL_RF(ir->coulombtype) && ir->epsilon_rf == 1 && ir->epsilon_r != 1)
1171 sprintf(warn_buf,
1172 "epsilon-r = %g and epsilon-rf = 1 with reaction field, proceeding assuming old "
1173 "format and exchanging epsilon-r and epsilon-rf",
1174 ir->epsilon_r);
1175 warning(wi, warn_buf);
1176 ir->epsilon_rf = ir->epsilon_r;
1177 ir->epsilon_r = 1.0;
1180 if (ir->epsilon_r == 0)
1182 sprintf(err_buf,
1183 "It is pointless to use long-range electrostatics with infinite relative "
1184 "permittivity."
1185 "Since you are effectively turning of electrostatics, a plain cutoff will be much "
1186 "faster.");
1187 CHECK(EEL_FULL(ir->coulombtype));
1190 if (getenv("GMX_DO_GALACTIC_DYNAMICS") == nullptr)
1192 sprintf(err_buf, "epsilon-r must be >= 0 instead of %g\n", ir->epsilon_r);
1193 CHECK(ir->epsilon_r < 0);
1196 if (EEL_RF(ir->coulombtype))
1198 /* reaction field (at the cut-off) */
1200 if (ir->coulombtype == eelRF_ZERO && ir->epsilon_rf != 0)
1202 sprintf(warn_buf,
1203 "With coulombtype = %s, epsilon-rf must be 0, assuming you meant epsilon_rf=0",
1204 eel_names[ir->coulombtype]);
1205 warning(wi, warn_buf);
1206 ir->epsilon_rf = 0.0;
1209 sprintf(err_buf, "epsilon-rf must be >= epsilon-r");
1210 CHECK((ir->epsilon_rf < ir->epsilon_r && ir->epsilon_rf != 0) || (ir->epsilon_r == 0));
1211 if (ir->epsilon_rf == ir->epsilon_r)
1213 sprintf(warn_buf, "Using epsilon-rf = epsilon-r with %s does not make sense",
1214 eel_names[ir->coulombtype]);
1215 warning(wi, warn_buf);
1218 /* Allow rlist>rcoulomb for tabulated long range stuff. This just
1219 * means the interaction is zero outside rcoulomb, but it helps to
1220 * provide accurate energy conservation.
1222 if (ir_coulomb_might_be_zero_at_cutoff(ir))
1224 if (ir_coulomb_switched(ir))
1226 sprintf(err_buf,
1227 "With coulombtype = %s rcoulomb_switch must be < rcoulomb. Or, better: Use the "
1228 "potential modifier options!",
1229 eel_names[ir->coulombtype]);
1230 CHECK(ir->rcoulomb_switch >= ir->rcoulomb);
1234 if (ir->coulombtype == eelSWITCH || ir->coulombtype == eelSHIFT)
1236 sprintf(err_buf,
1237 "Explicit switch/shift coulomb interactions cannot be used in combination with a "
1238 "secondary coulomb-modifier.");
1239 CHECK(ir->coulomb_modifier != eintmodNONE);
1241 if (ir->vdwtype == evdwSWITCH || ir->vdwtype == evdwSHIFT)
1243 sprintf(err_buf,
1244 "Explicit switch/shift vdw interactions cannot be used in combination with a "
1245 "secondary vdw-modifier.");
1246 CHECK(ir->vdw_modifier != eintmodNONE);
1249 if (ir->coulombtype == eelSWITCH || ir->coulombtype == eelSHIFT || ir->vdwtype == evdwSWITCH
1250 || ir->vdwtype == evdwSHIFT)
1252 sprintf(warn_buf,
1253 "The switch/shift interaction settings are just for compatibility; you will get "
1254 "better "
1255 "performance from applying potential modifiers to your interactions!\n");
1256 warning_note(wi, warn_buf);
1259 if (ir->coulombtype == eelPMESWITCH || ir->coulomb_modifier == eintmodPOTSWITCH)
1261 if (ir->rcoulomb_switch / ir->rcoulomb < 0.9499)
1263 real percentage = 100 * (ir->rcoulomb - ir->rcoulomb_switch) / ir->rcoulomb;
1264 sprintf(warn_buf,
1265 "The switching range should be 5%% or less (currently %.2f%% using a switching "
1266 "range of %4f-%4f) for accurate electrostatic energies, energy conservation "
1267 "will be good regardless, since ewald_rtol = %g.",
1268 percentage, ir->rcoulomb_switch, ir->rcoulomb, ir->ewald_rtol);
1269 warning(wi, warn_buf);
1273 if (ir->vdwtype == evdwSWITCH || ir->vdw_modifier == eintmodPOTSWITCH)
1275 if (ir->rvdw_switch == 0)
1277 sprintf(warn_buf,
1278 "rvdw-switch is equal 0 even though you are using a switched Lennard-Jones "
1279 "potential. This suggests it was not set in the mdp, which can lead to large "
1280 "energy errors. In GROMACS, 0.05 to 0.1 nm is often a reasonable vdw "
1281 "switching range.");
1282 warning(wi, warn_buf);
1286 if (EEL_FULL(ir->coulombtype))
1288 if (ir->coulombtype == eelPMESWITCH || ir->coulombtype == eelPMEUSER
1289 || ir->coulombtype == eelPMEUSERSWITCH)
1291 sprintf(err_buf, "With coulombtype = %s, rcoulomb must be <= rlist",
1292 eel_names[ir->coulombtype]);
1293 CHECK(ir->rcoulomb > ir->rlist);
1297 if (EEL_PME(ir->coulombtype) || EVDW_PME(ir->vdwtype))
1299 // TODO: Move these checks into the ewald module with the options class
1300 int orderMin = 3;
1301 int orderMax = (ir->coulombtype == eelP3M_AD ? 8 : 12);
1303 if (ir->pme_order < orderMin || ir->pme_order > orderMax)
1305 sprintf(warn_buf, "With coulombtype = %s, you should have %d <= pme-order <= %d",
1306 eel_names[ir->coulombtype], orderMin, orderMax);
1307 warning_error(wi, warn_buf);
1311 if (ir->nwall == 2 && EEL_FULL(ir->coulombtype))
1313 if (ir->ewald_geometry == eewg3D)
1315 sprintf(warn_buf, "With pbc=%s you should use ewald-geometry=%s",
1316 c_pbcTypeNames[ir->pbcType].c_str(), eewg_names[eewg3DC]);
1317 warning(wi, warn_buf);
1319 /* This check avoids extra pbc coding for exclusion corrections */
1320 sprintf(err_buf, "wall-ewald-zfac should be >= 2");
1321 CHECK(ir->wall_ewald_zfac < 2);
1323 if ((ir->ewald_geometry == eewg3DC) && (ir->pbcType != PbcType::XY) && EEL_FULL(ir->coulombtype))
1325 sprintf(warn_buf, "With %s and ewald_geometry = %s you should use pbc = %s",
1326 eel_names[ir->coulombtype], eewg_names[eewg3DC], c_pbcTypeNames[PbcType::XY].c_str());
1327 warning(wi, warn_buf);
1329 if ((ir->epsilon_surface != 0) && EEL_FULL(ir->coulombtype))
1331 sprintf(err_buf, "Cannot have periodic molecules with epsilon_surface > 0");
1332 CHECK(ir->bPeriodicMols);
1333 sprintf(warn_buf, "With epsilon_surface > 0 all molecules should be neutral.");
1334 warning_note(wi, warn_buf);
1335 sprintf(warn_buf,
1336 "With epsilon_surface > 0 you can only use domain decomposition "
1337 "when there are only small molecules with all bonds constrained (mdrun will check "
1338 "for this).");
1339 warning_note(wi, warn_buf);
1342 if (ir_vdw_switched(ir))
1344 sprintf(err_buf, "With switched vdw forces or potentials, rvdw-switch must be < rvdw");
1345 CHECK(ir->rvdw_switch >= ir->rvdw);
1347 if (ir->rvdw_switch < 0.5 * ir->rvdw)
1349 sprintf(warn_buf,
1350 "You are applying a switch function to vdw forces or potentials from %g to %g "
1351 "nm, which is more than half the interaction range, whereas switch functions "
1352 "are intended to act only close to the cut-off.",
1353 ir->rvdw_switch, ir->rvdw);
1354 warning_note(wi, warn_buf);
1358 if (ir->vdwtype == evdwPME)
1360 if (!(ir->vdw_modifier == eintmodNONE || ir->vdw_modifier == eintmodPOTSHIFT))
1362 sprintf(err_buf, "With vdwtype = %s, the only supported modifiers are %s and %s",
1363 evdw_names[ir->vdwtype], eintmod_names[eintmodPOTSHIFT], eintmod_names[eintmodNONE]);
1364 warning_error(wi, err_buf);
1368 if (ir->vdwtype == evdwUSER && ir->eDispCorr != edispcNO)
1370 warning_note(wi,
1371 "You have selected user tables with dispersion correction, the dispersion "
1372 "will be corrected to -C6/r^6 beyond rvdw_switch (the tabulated interaction "
1373 "between rvdw_switch and rvdw will not be double counted). Make sure that you "
1374 "really want dispersion correction to -C6/r^6.");
1377 if (ir->eI == eiLBFGS && (ir->coulombtype == eelCUT || ir->vdwtype == evdwCUT) && ir->rvdw != 0)
1379 warning(wi, "For efficient BFGS minimization, use switch/shift/pme instead of cut-off.");
1382 if (ir->eI == eiLBFGS && ir->nbfgscorr <= 0)
1384 warning(wi, "Using L-BFGS with nbfgscorr<=0 just gets you steepest descent.");
1387 /* IMPLICIT SOLVENT */
1388 if (ir->coulombtype == eelGB_NOTUSED)
1390 sprintf(warn_buf, "Invalid option %s for coulombtype", eel_names[ir->coulombtype]);
1391 warning_error(wi, warn_buf);
1394 if (ir->bQMMM)
1396 warning_error(wi, "The QMMM integration you are trying to use is no longer supported");
1399 if (ir->bAdress)
1401 gmx_fatal(FARGS, "AdResS simulations are no longer supported");
1405 /* interpret a number of doubles from a string and put them in an array,
1406 after allocating space for them.
1407 str = the input string
1408 n = the (pre-allocated) number of doubles read
1409 r = the output array of doubles. */
1410 static void parse_n_real(char* str, int* n, real** r, warninp_t wi)
1412 auto values = gmx::splitString(str);
1413 *n = values.size();
1415 snew(*r, *n);
1416 for (int i = 0; i < *n; i++)
1420 (*r)[i] = gmx::fromString<real>(values[i]);
1422 catch (gmx::GromacsException&)
1424 warning_error(wi, "Invalid value " + values[i]
1425 + " in string in mdp file. Expected a real number.");
1431 static void do_fep_params(t_inputrec* ir, char fep_lambda[][STRLEN], char weights[STRLEN], warninp_t wi)
1434 int i, j, max_n_lambda, nweights, nfep[efptNR];
1435 t_lambda* fep = ir->fepvals;
1436 t_expanded* expand = ir->expandedvals;
1437 real** count_fep_lambdas;
1438 bool bOneLambda = TRUE;
1440 snew(count_fep_lambdas, efptNR);
1442 /* FEP input processing */
1443 /* first, identify the number of lambda values for each type.
1444 All that are nonzero must have the same number */
1446 for (i = 0; i < efptNR; i++)
1448 parse_n_real(fep_lambda[i], &(nfep[i]), &(count_fep_lambdas[i]), wi);
1451 /* now, determine the number of components. All must be either zero, or equal. */
1453 max_n_lambda = 0;
1454 for (i = 0; i < efptNR; i++)
1456 if (nfep[i] > max_n_lambda)
1458 max_n_lambda = nfep[i]; /* here's a nonzero one. All of them
1459 must have the same number if its not zero.*/
1460 break;
1464 for (i = 0; i < efptNR; i++)
1466 if (nfep[i] == 0)
1468 ir->fepvals->separate_dvdl[i] = FALSE;
1470 else if (nfep[i] == max_n_lambda)
1472 if (i != efptTEMPERATURE) /* we treat this differently -- not really a reason to compute
1473 the derivative with respect to the temperature currently */
1475 ir->fepvals->separate_dvdl[i] = TRUE;
1478 else
1480 gmx_fatal(FARGS,
1481 "Number of lambdas (%d) for FEP type %s not equal to number of other types "
1482 "(%d)",
1483 nfep[i], efpt_names[i], max_n_lambda);
1486 /* we don't print out dhdl if the temperature is changing, since we can't correctly define dhdl in this case */
1487 ir->fepvals->separate_dvdl[efptTEMPERATURE] = FALSE;
1489 /* the number of lambdas is the number we've read in, which is either zero
1490 or the same for all */
1491 fep->n_lambda = max_n_lambda;
1493 /* allocate space for the array of lambda values */
1494 snew(fep->all_lambda, efptNR);
1495 /* if init_lambda is defined, we need to set lambda */
1496 if ((fep->init_lambda > 0) && (fep->n_lambda == 0))
1498 ir->fepvals->separate_dvdl[efptFEP] = TRUE;
1500 /* otherwise allocate the space for all of the lambdas, and transfer the data */
1501 for (i = 0; i < efptNR; i++)
1503 snew(fep->all_lambda[i], fep->n_lambda);
1504 if (nfep[i] > 0) /* if it's zero, then the count_fep_lambda arrays
1505 are zero */
1507 for (j = 0; j < fep->n_lambda; j++)
1509 fep->all_lambda[i][j] = static_cast<double>(count_fep_lambdas[i][j]);
1511 sfree(count_fep_lambdas[i]);
1514 sfree(count_fep_lambdas);
1516 /* "fep-vals" is either zero or the full number. If zero, we'll need to define fep-lambdas for
1517 internal bookkeeping -- for now, init_lambda */
1519 if ((nfep[efptFEP] == 0) && (fep->init_lambda >= 0))
1521 for (i = 0; i < fep->n_lambda; i++)
1523 fep->all_lambda[efptFEP][i] = fep->init_lambda;
1527 /* check to see if only a single component lambda is defined, and soft core is defined.
1528 In this case, turn on coulomb soft core */
1530 if (max_n_lambda == 0)
1532 bOneLambda = TRUE;
1534 else
1536 for (i = 0; i < efptNR; i++)
1538 if ((nfep[i] != 0) && (i != efptFEP))
1540 bOneLambda = FALSE;
1544 if ((bOneLambda) && (fep->sc_alpha > 0))
1546 fep->bScCoul = TRUE;
1549 /* Fill in the others with the efptFEP if they are not explicitly
1550 specified (i.e. nfep[i] == 0). This means if fep is not defined,
1551 they are all zero. */
1553 for (i = 0; i < efptNR; i++)
1555 if ((nfep[i] == 0) && (i != efptFEP))
1557 for (j = 0; j < fep->n_lambda; j++)
1559 fep->all_lambda[i][j] = fep->all_lambda[efptFEP][j];
1565 /* now read in the weights */
1566 parse_n_real(weights, &nweights, &(expand->init_lambda_weights), wi);
1567 if (nweights == 0)
1569 snew(expand->init_lambda_weights, fep->n_lambda); /* initialize to zero */
1571 else if (nweights != fep->n_lambda)
1573 gmx_fatal(FARGS, "Number of weights (%d) is not equal to number of lambda values (%d)",
1574 nweights, fep->n_lambda);
1576 if ((expand->nstexpanded < 0) && (ir->efep != efepNO))
1578 expand->nstexpanded = fep->nstdhdl;
1579 /* if you don't specify nstexpanded when doing expanded ensemble free energy calcs, it is set to nstdhdl */
1584 static void do_simtemp_params(t_inputrec* ir)
1587 snew(ir->simtempvals->temperatures, ir->fepvals->n_lambda);
1588 GetSimTemps(ir->fepvals->n_lambda, ir->simtempvals, ir->fepvals->all_lambda[efptTEMPERATURE]);
1591 template<typename T>
1592 void convertInts(warninp_t wi, gmx::ArrayRef<const std::string> inputs, const char* name, T* outputs)
1594 int i = 0;
1595 for (const auto& input : inputs)
1599 outputs[i] = gmx::fromStdString<T>(input);
1601 catch (gmx::GromacsException&)
1603 auto message = gmx::formatString(
1604 "Invalid value for mdp option %s. %s should only consist of integers separated "
1605 "by spaces.",
1606 name, name);
1607 warning_error(wi, message);
1609 ++i;
1613 static void convertReals(warninp_t wi, gmx::ArrayRef<const std::string> inputs, const char* name, real* outputs)
1615 int i = 0;
1616 for (const auto& input : inputs)
1620 outputs[i] = gmx::fromString<real>(input);
1622 catch (gmx::GromacsException&)
1624 auto message = gmx::formatString(
1625 "Invalid value for mdp option %s. %s should only consist of real numbers "
1626 "separated by spaces.",
1627 name, name);
1628 warning_error(wi, message);
1630 ++i;
1634 static void convertRvecs(warninp_t wi, gmx::ArrayRef<const std::string> inputs, const char* name, rvec* outputs)
1636 int i = 0, d = 0;
1637 for (const auto& input : inputs)
1641 outputs[i][d] = gmx::fromString<real>(input);
1643 catch (gmx::GromacsException&)
1645 auto message = gmx::formatString(
1646 "Invalid value for mdp option %s. %s should only consist of real numbers "
1647 "separated by spaces.",
1648 name, name);
1649 warning_error(wi, message);
1651 ++d;
1652 if (d == DIM)
1654 d = 0;
1655 ++i;
1660 static void do_wall_params(t_inputrec* ir, char* wall_atomtype, char* wall_density, t_gromppopts* opts, warninp_t wi)
1662 opts->wall_atomtype[0] = nullptr;
1663 opts->wall_atomtype[1] = nullptr;
1665 ir->wall_atomtype[0] = -1;
1666 ir->wall_atomtype[1] = -1;
1667 ir->wall_density[0] = 0;
1668 ir->wall_density[1] = 0;
1670 if (ir->nwall > 0)
1672 auto wallAtomTypes = gmx::splitString(wall_atomtype);
1673 if (wallAtomTypes.size() != size_t(ir->nwall))
1675 gmx_fatal(FARGS, "Expected %d elements for wall_atomtype, found %zu", ir->nwall,
1676 wallAtomTypes.size());
1678 for (int i = 0; i < ir->nwall; i++)
1680 opts->wall_atomtype[i] = gmx_strdup(wallAtomTypes[i].c_str());
1683 if (ir->wall_type == ewt93 || ir->wall_type == ewt104)
1685 auto wallDensity = gmx::splitString(wall_density);
1686 if (wallDensity.size() != size_t(ir->nwall))
1688 gmx_fatal(FARGS, "Expected %d elements for wall-density, found %zu", ir->nwall,
1689 wallDensity.size());
1691 convertReals(wi, wallDensity, "wall-density", ir->wall_density);
1692 for (int i = 0; i < ir->nwall; i++)
1694 if (ir->wall_density[i] <= 0)
1696 gmx_fatal(FARGS, "wall-density[%d] = %f\n", i, ir->wall_density[i]);
1703 static void add_wall_energrps(SimulationGroups* groups, int nwall, t_symtab* symtab)
1705 if (nwall > 0)
1707 AtomGroupIndices* grps = &(groups->groups[SimulationAtomGroupType::EnergyOutput]);
1708 for (int i = 0; i < nwall; i++)
1710 groups->groupNames.emplace_back(put_symtab(symtab, gmx::formatString("wall%d", i).c_str()));
1711 grps->emplace_back(groups->groupNames.size() - 1);
1716 static void read_expandedparams(std::vector<t_inpfile>* inp, t_expanded* expand, warninp_t wi)
1718 /* read expanded ensemble parameters */
1719 printStringNewline(inp, "expanded ensemble variables");
1720 expand->nstexpanded = get_eint(inp, "nstexpanded", -1, wi);
1721 expand->elamstats = get_eeenum(inp, "lmc-stats", elamstats_names, wi);
1722 expand->elmcmove = get_eeenum(inp, "lmc-move", elmcmove_names, wi);
1723 expand->elmceq = get_eeenum(inp, "lmc-weights-equil", elmceq_names, wi);
1724 expand->equil_n_at_lam = get_eint(inp, "weight-equil-number-all-lambda", -1, wi);
1725 expand->equil_samples = get_eint(inp, "weight-equil-number-samples", -1, wi);
1726 expand->equil_steps = get_eint(inp, "weight-equil-number-steps", -1, wi);
1727 expand->equil_wl_delta = get_ereal(inp, "weight-equil-wl-delta", -1, wi);
1728 expand->equil_ratio = get_ereal(inp, "weight-equil-count-ratio", -1, wi);
1729 printStringNewline(inp, "Seed for Monte Carlo in lambda space");
1730 expand->lmc_seed = get_eint(inp, "lmc-seed", -1, wi);
1731 expand->mc_temp = get_ereal(inp, "mc-temperature", -1, wi);
1732 expand->lmc_repeats = get_eint(inp, "lmc-repeats", 1, wi);
1733 expand->gibbsdeltalam = get_eint(inp, "lmc-gibbsdelta", -1, wi);
1734 expand->lmc_forced_nstart = get_eint(inp, "lmc-forced-nstart", 0, wi);
1735 expand->bSymmetrizedTMatrix =
1736 (get_eeenum(inp, "symmetrized-transition-matrix", yesno_names, wi) != 0);
1737 expand->nstTij = get_eint(inp, "nst-transition-matrix", -1, wi);
1738 expand->minvarmin = get_eint(inp, "mininum-var-min", 100, wi); /*default is reasonable */
1739 expand->c_range = get_eint(inp, "weight-c-range", 0, wi); /* default is just C=0 */
1740 expand->wl_scale = get_ereal(inp, "wl-scale", 0.8, wi);
1741 expand->wl_ratio = get_ereal(inp, "wl-ratio", 0.8, wi);
1742 expand->init_wl_delta = get_ereal(inp, "init-wl-delta", 1.0, wi);
1743 expand->bWLoneovert = (get_eeenum(inp, "wl-oneovert", yesno_names, wi) != 0);
1746 /*! \brief Return whether an end state with the given coupling-lambda
1747 * value describes fully-interacting VDW.
1749 * \param[in] couple_lambda_value Enumeration ecouplam value describing the end state
1750 * \return Whether VDW is on (i.e. the user chose vdw or vdw-q in the .mdp file)
1752 static bool couple_lambda_has_vdw_on(int couple_lambda_value)
1754 return (couple_lambda_value == ecouplamVDW || couple_lambda_value == ecouplamVDWQ);
1757 namespace
1760 class MdpErrorHandler : public gmx::IKeyValueTreeErrorHandler
1762 public:
1763 explicit MdpErrorHandler(warninp_t wi) : wi_(wi), mapping_(nullptr) {}
1765 void setBackMapping(const gmx::IKeyValueTreeBackMapping& mapping) { mapping_ = &mapping; }
1767 bool onError(gmx::UserInputError* ex, const gmx::KeyValueTreePath& context) override
1769 ex->prependContext(
1770 gmx::formatString("Error in mdp option \"%s\":", getOptionName(context).c_str()));
1771 std::string message = gmx::formatExceptionMessageToString(*ex);
1772 warning_error(wi_, message.c_str());
1773 return true;
1776 private:
1777 std::string getOptionName(const gmx::KeyValueTreePath& context)
1779 if (mapping_ != nullptr)
1781 gmx::KeyValueTreePath path = mapping_->originalPath(context);
1782 GMX_ASSERT(path.size() == 1, "Inconsistent mapping back to mdp options");
1783 return path[0];
1785 GMX_ASSERT(context.size() == 1, "Inconsistent context for mdp option parsing");
1786 return context[0];
1789 warninp_t wi_;
1790 const gmx::IKeyValueTreeBackMapping* mapping_;
1793 } // namespace
1795 void get_ir(const char* mdparin,
1796 const char* mdparout,
1797 gmx::MDModules* mdModules,
1798 t_inputrec* ir,
1799 t_gromppopts* opts,
1800 WriteMdpHeader writeMdpHeader,
1801 warninp_t wi)
1803 char* dumstr[2];
1804 double dumdub[2][6];
1805 int i, j, m;
1806 char warn_buf[STRLEN];
1807 t_lambda* fep = ir->fepvals;
1808 t_expanded* expand = ir->expandedvals;
1810 const char* no_names[] = { "no", nullptr };
1812 init_inputrec_strings();
1813 gmx::TextInputFile stream(mdparin);
1814 std::vector<t_inpfile> inp = read_inpfile(&stream, mdparin, wi);
1816 snew(dumstr[0], STRLEN);
1817 snew(dumstr[1], STRLEN);
1819 /* ignore the following deprecated commands */
1820 replace_inp_entry(inp, "title", nullptr);
1821 replace_inp_entry(inp, "cpp", nullptr);
1822 replace_inp_entry(inp, "domain-decomposition", nullptr);
1823 replace_inp_entry(inp, "andersen-seed", nullptr);
1824 replace_inp_entry(inp, "dihre", nullptr);
1825 replace_inp_entry(inp, "dihre-fc", nullptr);
1826 replace_inp_entry(inp, "dihre-tau", nullptr);
1827 replace_inp_entry(inp, "nstdihreout", nullptr);
1828 replace_inp_entry(inp, "nstcheckpoint", nullptr);
1829 replace_inp_entry(inp, "optimize-fft", nullptr);
1830 replace_inp_entry(inp, "adress_type", nullptr);
1831 replace_inp_entry(inp, "adress_const_wf", nullptr);
1832 replace_inp_entry(inp, "adress_ex_width", nullptr);
1833 replace_inp_entry(inp, "adress_hy_width", nullptr);
1834 replace_inp_entry(inp, "adress_ex_forcecap", nullptr);
1835 replace_inp_entry(inp, "adress_interface_correction", nullptr);
1836 replace_inp_entry(inp, "adress_site", nullptr);
1837 replace_inp_entry(inp, "adress_reference_coords", nullptr);
1838 replace_inp_entry(inp, "adress_tf_grp_names", nullptr);
1839 replace_inp_entry(inp, "adress_cg_grp_names", nullptr);
1840 replace_inp_entry(inp, "adress_do_hybridpairs", nullptr);
1841 replace_inp_entry(inp, "rlistlong", nullptr);
1842 replace_inp_entry(inp, "nstcalclr", nullptr);
1843 replace_inp_entry(inp, "pull-print-com2", nullptr);
1844 replace_inp_entry(inp, "gb-algorithm", nullptr);
1845 replace_inp_entry(inp, "nstgbradii", nullptr);
1846 replace_inp_entry(inp, "rgbradii", nullptr);
1847 replace_inp_entry(inp, "gb-epsilon-solvent", nullptr);
1848 replace_inp_entry(inp, "gb-saltconc", nullptr);
1849 replace_inp_entry(inp, "gb-obc-alpha", nullptr);
1850 replace_inp_entry(inp, "gb-obc-beta", nullptr);
1851 replace_inp_entry(inp, "gb-obc-gamma", nullptr);
1852 replace_inp_entry(inp, "gb-dielectric-offset", nullptr);
1853 replace_inp_entry(inp, "sa-algorithm", nullptr);
1854 replace_inp_entry(inp, "sa-surface-tension", nullptr);
1855 replace_inp_entry(inp, "ns-type", nullptr);
1857 /* replace the following commands with the clearer new versions*/
1858 replace_inp_entry(inp, "unconstrained-start", "continuation");
1859 replace_inp_entry(inp, "foreign-lambda", "fep-lambdas");
1860 replace_inp_entry(inp, "verlet-buffer-drift", "verlet-buffer-tolerance");
1861 replace_inp_entry(inp, "nstxtcout", "nstxout-compressed");
1862 replace_inp_entry(inp, "xtc-grps", "compressed-x-grps");
1863 replace_inp_entry(inp, "xtc-precision", "compressed-x-precision");
1864 replace_inp_entry(inp, "pull-print-com1", "pull-print-com");
1866 printStringNewline(&inp, "VARIOUS PREPROCESSING OPTIONS");
1867 printStringNoNewline(&inp, "Preprocessor information: use cpp syntax.");
1868 printStringNoNewline(&inp, "e.g.: -I/home/joe/doe -I/home/mary/roe");
1869 setStringEntry(&inp, "include", opts->include, nullptr);
1870 printStringNoNewline(
1871 &inp, "e.g.: -DPOSRES -DFLEXIBLE (note these variable names are case sensitive)");
1872 setStringEntry(&inp, "define", opts->define, nullptr);
1874 printStringNewline(&inp, "RUN CONTROL PARAMETERS");
1875 ir->eI = get_eeenum(&inp, "integrator", ei_names, wi);
1876 printStringNoNewline(&inp, "Start time and timestep in ps");
1877 ir->init_t = get_ereal(&inp, "tinit", 0.0, wi);
1878 ir->delta_t = get_ereal(&inp, "dt", 0.001, wi);
1879 ir->nsteps = get_eint64(&inp, "nsteps", 0, wi);
1880 printStringNoNewline(&inp, "For exact run continuation or redoing part of a run");
1881 ir->init_step = get_eint64(&inp, "init-step", 0, wi);
1882 printStringNoNewline(
1883 &inp, "Part index is updated automatically on checkpointing (keeps files separate)");
1884 ir->simulation_part = get_eint(&inp, "simulation-part", 1, wi);
1885 printStringNoNewline(&inp, "mode for center of mass motion removal");
1886 ir->comm_mode = get_eeenum(&inp, "comm-mode", ecm_names, wi);
1887 printStringNoNewline(&inp, "number of steps for center of mass motion removal");
1888 ir->nstcomm = get_eint(&inp, "nstcomm", 100, wi);
1889 printStringNoNewline(&inp, "group(s) for center of mass motion removal");
1890 setStringEntry(&inp, "comm-grps", inputrecStrings->vcm, nullptr);
1892 printStringNewline(&inp, "LANGEVIN DYNAMICS OPTIONS");
1893 printStringNoNewline(&inp, "Friction coefficient (amu/ps) and random seed");
1894 ir->bd_fric = get_ereal(&inp, "bd-fric", 0.0, wi);
1895 ir->ld_seed = get_eint64(&inp, "ld-seed", -1, wi);
1897 /* Em stuff */
1898 printStringNewline(&inp, "ENERGY MINIMIZATION OPTIONS");
1899 printStringNoNewline(&inp, "Force tolerance and initial step-size");
1900 ir->em_tol = get_ereal(&inp, "emtol", 10.0, wi);
1901 ir->em_stepsize = get_ereal(&inp, "emstep", 0.01, wi);
1902 printStringNoNewline(&inp, "Max number of iterations in relax-shells");
1903 ir->niter = get_eint(&inp, "niter", 20, wi);
1904 printStringNoNewline(&inp, "Step size (ps^2) for minimization of flexible constraints");
1905 ir->fc_stepsize = get_ereal(&inp, "fcstep", 0, wi);
1906 printStringNoNewline(&inp, "Frequency of steepest descents steps when doing CG");
1907 ir->nstcgsteep = get_eint(&inp, "nstcgsteep", 1000, wi);
1908 ir->nbfgscorr = get_eint(&inp, "nbfgscorr", 10, wi);
1910 printStringNewline(&inp, "TEST PARTICLE INSERTION OPTIONS");
1911 ir->rtpi = get_ereal(&inp, "rtpi", 0.05, wi);
1913 /* Output options */
1914 printStringNewline(&inp, "OUTPUT CONTROL OPTIONS");
1915 printStringNoNewline(&inp, "Output frequency for coords (x), velocities (v) and forces (f)");
1916 ir->nstxout = get_eint(&inp, "nstxout", 0, wi);
1917 ir->nstvout = get_eint(&inp, "nstvout", 0, wi);
1918 ir->nstfout = get_eint(&inp, "nstfout", 0, wi);
1919 printStringNoNewline(&inp, "Output frequency for energies to log file and energy file");
1920 ir->nstlog = get_eint(&inp, "nstlog", 1000, wi);
1921 ir->nstcalcenergy = get_eint(&inp, "nstcalcenergy", 100, wi);
1922 ir->nstenergy = get_eint(&inp, "nstenergy", 1000, wi);
1923 printStringNoNewline(&inp, "Output frequency and precision for .xtc file");
1924 ir->nstxout_compressed = get_eint(&inp, "nstxout-compressed", 0, wi);
1925 ir->x_compression_precision = get_ereal(&inp, "compressed-x-precision", 1000.0, wi);
1926 printStringNoNewline(&inp, "This selects the subset of atoms for the compressed");
1927 printStringNoNewline(&inp, "trajectory file. You can select multiple groups. By");
1928 printStringNoNewline(&inp, "default, all atoms will be written.");
1929 setStringEntry(&inp, "compressed-x-grps", inputrecStrings->x_compressed_groups, nullptr);
1930 printStringNoNewline(&inp, "Selection of energy groups");
1931 setStringEntry(&inp, "energygrps", inputrecStrings->energy, nullptr);
1933 /* Neighbor searching */
1934 printStringNewline(&inp, "NEIGHBORSEARCHING PARAMETERS");
1935 printStringNoNewline(&inp, "cut-off scheme (Verlet: particle based cut-offs)");
1936 ir->cutoff_scheme = get_eeenum(&inp, "cutoff-scheme", ecutscheme_names, wi);
1937 printStringNoNewline(&inp, "nblist update frequency");
1938 ir->nstlist = get_eint(&inp, "nstlist", 10, wi);
1939 printStringNoNewline(&inp, "Periodic boundary conditions: xyz, no, xy");
1940 // TODO This conversion should be removed when proper std:string handling will be added to get_eeenum(...), etc.
1941 std::vector<const char*> pbcTypesNamesChar;
1942 for (const auto& pbcTypeName : c_pbcTypeNames)
1944 pbcTypesNamesChar.push_back(pbcTypeName.c_str());
1946 ir->pbcType = static_cast<PbcType>(get_eeenum(&inp, "pbc", pbcTypesNamesChar.data(), wi));
1947 ir->bPeriodicMols = get_eeenum(&inp, "periodic-molecules", yesno_names, wi) != 0;
1948 printStringNoNewline(&inp,
1949 "Allowed energy error due to the Verlet buffer in kJ/mol/ps per atom,");
1950 printStringNoNewline(&inp, "a value of -1 means: use rlist");
1951 ir->verletbuf_tol = get_ereal(&inp, "verlet-buffer-tolerance", 0.005, wi);
1952 printStringNoNewline(&inp, "nblist cut-off");
1953 ir->rlist = get_ereal(&inp, "rlist", 1.0, wi);
1954 printStringNoNewline(&inp, "long-range cut-off for switched potentials");
1956 /* Electrostatics */
1957 printStringNewline(&inp, "OPTIONS FOR ELECTROSTATICS AND VDW");
1958 printStringNoNewline(&inp, "Method for doing electrostatics");
1959 ir->coulombtype = get_eeenum(&inp, "coulombtype", eel_names, wi);
1960 ir->coulomb_modifier = get_eeenum(&inp, "coulomb-modifier", eintmod_names, wi);
1961 printStringNoNewline(&inp, "cut-off lengths");
1962 ir->rcoulomb_switch = get_ereal(&inp, "rcoulomb-switch", 0.0, wi);
1963 ir->rcoulomb = get_ereal(&inp, "rcoulomb", 1.0, wi);
1964 printStringNoNewline(&inp,
1965 "Relative dielectric constant for the medium and the reaction field");
1966 ir->epsilon_r = get_ereal(&inp, "epsilon-r", 1.0, wi);
1967 ir->epsilon_rf = get_ereal(&inp, "epsilon-rf", 0.0, wi);
1968 printStringNoNewline(&inp, "Method for doing Van der Waals");
1969 ir->vdwtype = get_eeenum(&inp, "vdw-type", evdw_names, wi);
1970 ir->vdw_modifier = get_eeenum(&inp, "vdw-modifier", eintmod_names, wi);
1971 printStringNoNewline(&inp, "cut-off lengths");
1972 ir->rvdw_switch = get_ereal(&inp, "rvdw-switch", 0.0, wi);
1973 ir->rvdw = get_ereal(&inp, "rvdw", 1.0, wi);
1974 printStringNoNewline(&inp, "Apply long range dispersion corrections for Energy and Pressure");
1975 ir->eDispCorr = get_eeenum(&inp, "DispCorr", edispc_names, wi);
1976 printStringNoNewline(&inp, "Extension of the potential lookup tables beyond the cut-off");
1977 ir->tabext = get_ereal(&inp, "table-extension", 1.0, wi);
1978 printStringNoNewline(&inp, "Separate tables between energy group pairs");
1979 setStringEntry(&inp, "energygrp-table", inputrecStrings->egptable, nullptr);
1980 printStringNoNewline(&inp, "Spacing for the PME/PPPM FFT grid");
1981 ir->fourier_spacing = get_ereal(&inp, "fourierspacing", 0.12, wi);
1982 printStringNoNewline(&inp, "FFT grid size, when a value is 0 fourierspacing will be used");
1983 ir->nkx = get_eint(&inp, "fourier-nx", 0, wi);
1984 ir->nky = get_eint(&inp, "fourier-ny", 0, wi);
1985 ir->nkz = get_eint(&inp, "fourier-nz", 0, wi);
1986 printStringNoNewline(&inp, "EWALD/PME/PPPM parameters");
1987 ir->pme_order = get_eint(&inp, "pme-order", 4, wi);
1988 ir->ewald_rtol = get_ereal(&inp, "ewald-rtol", 0.00001, wi);
1989 ir->ewald_rtol_lj = get_ereal(&inp, "ewald-rtol-lj", 0.001, wi);
1990 ir->ljpme_combination_rule = get_eeenum(&inp, "lj-pme-comb-rule", eljpme_names, wi);
1991 ir->ewald_geometry = get_eeenum(&inp, "ewald-geometry", eewg_names, wi);
1992 ir->epsilon_surface = get_ereal(&inp, "epsilon-surface", 0.0, wi);
1994 /* Implicit solvation is no longer supported, but we need grompp
1995 to be able to refuse old .mdp files that would have built a tpr
1996 to run it. Thus, only "no" is accepted. */
1997 ir->implicit_solvent = (get_eeenum(&inp, "implicit-solvent", no_names, wi) != 0);
1999 /* Coupling stuff */
2000 printStringNewline(&inp, "OPTIONS FOR WEAK COUPLING ALGORITHMS");
2001 printStringNoNewline(&inp, "Temperature coupling");
2002 ir->etc = get_eeenum(&inp, "tcoupl", etcoupl_names, wi);
2003 ir->nsttcouple = get_eint(&inp, "nsttcouple", -1, wi);
2004 ir->opts.nhchainlength = get_eint(&inp, "nh-chain-length", 10, wi);
2005 ir->bPrintNHChains = (get_eeenum(&inp, "print-nose-hoover-chain-variables", yesno_names, wi) != 0);
2006 printStringNoNewline(&inp, "Groups to couple separately");
2007 setStringEntry(&inp, "tc-grps", inputrecStrings->tcgrps, nullptr);
2008 printStringNoNewline(&inp, "Time constant (ps) and reference temperature (K)");
2009 setStringEntry(&inp, "tau-t", inputrecStrings->tau_t, nullptr);
2010 setStringEntry(&inp, "ref-t", inputrecStrings->ref_t, nullptr);
2011 printStringNoNewline(&inp, "pressure coupling");
2012 ir->epc = get_eeenum(&inp, "pcoupl", epcoupl_names, wi);
2013 ir->epct = get_eeenum(&inp, "pcoupltype", epcoupltype_names, wi);
2014 ir->nstpcouple = get_eint(&inp, "nstpcouple", -1, wi);
2015 printStringNoNewline(&inp, "Time constant (ps), compressibility (1/bar) and reference P (bar)");
2016 ir->tau_p = get_ereal(&inp, "tau-p", 1.0, wi);
2017 setStringEntry(&inp, "compressibility", dumstr[0], nullptr);
2018 setStringEntry(&inp, "ref-p", dumstr[1], nullptr);
2019 printStringNoNewline(&inp, "Scaling of reference coordinates, No, All or COM");
2020 ir->refcoord_scaling = get_eeenum(&inp, "refcoord-scaling", erefscaling_names, wi);
2022 /* QMMM */
2023 printStringNewline(&inp, "OPTIONS FOR QMMM calculations");
2024 ir->bQMMM = (get_eeenum(&inp, "QMMM", yesno_names, wi) != 0);
2025 printStringNoNewline(&inp, "Groups treated Quantum Mechanically");
2026 setStringEntry(&inp, "QMMM-grps", inputrecStrings->QMMM, nullptr);
2027 printStringNoNewline(&inp, "QM method");
2028 setStringEntry(&inp, "QMmethod", inputrecStrings->QMmethod, nullptr);
2029 printStringNoNewline(&inp, "QMMM scheme");
2030 const char* noQMMMSchemeName = "normal";
2031 get_eeenum(&inp, "QMMMscheme", &noQMMMSchemeName, wi);
2032 printStringNoNewline(&inp, "QM basisset");
2033 setStringEntry(&inp, "QMbasis", inputrecStrings->QMbasis, nullptr);
2034 printStringNoNewline(&inp, "QM charge");
2035 setStringEntry(&inp, "QMcharge", inputrecStrings->QMcharge, nullptr);
2036 printStringNoNewline(&inp, "QM multiplicity");
2037 setStringEntry(&inp, "QMmult", inputrecStrings->QMmult, nullptr);
2038 printStringNoNewline(&inp, "Surface Hopping");
2039 setStringEntry(&inp, "SH", inputrecStrings->bSH, nullptr);
2040 printStringNoNewline(&inp, "CAS space options");
2041 setStringEntry(&inp, "CASorbitals", inputrecStrings->CASorbitals, nullptr);
2042 setStringEntry(&inp, "CASelectrons", inputrecStrings->CASelectrons, nullptr);
2043 setStringEntry(&inp, "SAon", inputrecStrings->SAon, nullptr);
2044 setStringEntry(&inp, "SAoff", inputrecStrings->SAoff, nullptr);
2045 setStringEntry(&inp, "SAsteps", inputrecStrings->SAsteps, nullptr);
2046 printStringNoNewline(&inp, "Scale factor for MM charges");
2047 get_ereal(&inp, "MMChargeScaleFactor", 1.0, wi);
2049 /* Simulated annealing */
2050 printStringNewline(&inp, "SIMULATED ANNEALING");
2051 printStringNoNewline(&inp, "Type of annealing for each temperature group (no/single/periodic)");
2052 setStringEntry(&inp, "annealing", inputrecStrings->anneal, nullptr);
2053 printStringNoNewline(&inp,
2054 "Number of time points to use for specifying annealing in each group");
2055 setStringEntry(&inp, "annealing-npoints", inputrecStrings->anneal_npoints, nullptr);
2056 printStringNoNewline(&inp, "List of times at the annealing points for each group");
2057 setStringEntry(&inp, "annealing-time", inputrecStrings->anneal_time, nullptr);
2058 printStringNoNewline(&inp, "Temp. at each annealing point, for each group.");
2059 setStringEntry(&inp, "annealing-temp", inputrecStrings->anneal_temp, nullptr);
2061 /* Startup run */
2062 printStringNewline(&inp, "GENERATE VELOCITIES FOR STARTUP RUN");
2063 opts->bGenVel = (get_eeenum(&inp, "gen-vel", yesno_names, wi) != 0);
2064 opts->tempi = get_ereal(&inp, "gen-temp", 300.0, wi);
2065 opts->seed = get_eint(&inp, "gen-seed", -1, wi);
2067 /* Shake stuff */
2068 printStringNewline(&inp, "OPTIONS FOR BONDS");
2069 opts->nshake = get_eeenum(&inp, "constraints", constraints, wi);
2070 printStringNoNewline(&inp, "Type of constraint algorithm");
2071 ir->eConstrAlg = get_eeenum(&inp, "constraint-algorithm", econstr_names, wi);
2072 printStringNoNewline(&inp, "Do not constrain the start configuration");
2073 ir->bContinuation = (get_eeenum(&inp, "continuation", yesno_names, wi) != 0);
2074 printStringNoNewline(&inp,
2075 "Use successive overrelaxation to reduce the number of shake iterations");
2076 ir->bShakeSOR = (get_eeenum(&inp, "Shake-SOR", yesno_names, wi) != 0);
2077 printStringNoNewline(&inp, "Relative tolerance of shake");
2078 ir->shake_tol = get_ereal(&inp, "shake-tol", 0.0001, wi);
2079 printStringNoNewline(&inp, "Highest order in the expansion of the constraint coupling matrix");
2080 ir->nProjOrder = get_eint(&inp, "lincs-order", 4, wi);
2081 printStringNoNewline(&inp, "Number of iterations in the final step of LINCS. 1 is fine for");
2082 printStringNoNewline(&inp, "normal simulations, but use 2 to conserve energy in NVE runs.");
2083 printStringNoNewline(&inp, "For energy minimization with constraints it should be 4 to 8.");
2084 ir->nLincsIter = get_eint(&inp, "lincs-iter", 1, wi);
2085 printStringNoNewline(&inp, "Lincs will write a warning to the stderr if in one step a bond");
2086 printStringNoNewline(&inp, "rotates over more degrees than");
2087 ir->LincsWarnAngle = get_ereal(&inp, "lincs-warnangle", 30.0, wi);
2088 printStringNoNewline(&inp, "Convert harmonic bonds to morse potentials");
2089 opts->bMorse = (get_eeenum(&inp, "morse", yesno_names, wi) != 0);
2091 /* Energy group exclusions */
2092 printStringNewline(&inp, "ENERGY GROUP EXCLUSIONS");
2093 printStringNoNewline(
2094 &inp, "Pairs of energy groups for which all non-bonded interactions are excluded");
2095 setStringEntry(&inp, "energygrp-excl", inputrecStrings->egpexcl, nullptr);
2097 /* Walls */
2098 printStringNewline(&inp, "WALLS");
2099 printStringNoNewline(
2100 &inp, "Number of walls, type, atom types, densities and box-z scale factor for Ewald");
2101 ir->nwall = get_eint(&inp, "nwall", 0, wi);
2102 ir->wall_type = get_eeenum(&inp, "wall-type", ewt_names, wi);
2103 ir->wall_r_linpot = get_ereal(&inp, "wall-r-linpot", -1, wi);
2104 setStringEntry(&inp, "wall-atomtype", inputrecStrings->wall_atomtype, nullptr);
2105 setStringEntry(&inp, "wall-density", inputrecStrings->wall_density, nullptr);
2106 ir->wall_ewald_zfac = get_ereal(&inp, "wall-ewald-zfac", 3, wi);
2108 /* COM pulling */
2109 printStringNewline(&inp, "COM PULLING");
2110 ir->bPull = (get_eeenum(&inp, "pull", yesno_names, wi) != 0);
2111 if (ir->bPull)
2113 snew(ir->pull, 1);
2114 inputrecStrings->pullGroupNames = read_pullparams(&inp, ir->pull, wi);
2117 /* AWH biasing
2118 NOTE: needs COM pulling input */
2119 printStringNewline(&inp, "AWH biasing");
2120 ir->bDoAwh = (get_eeenum(&inp, "awh", yesno_names, wi) != 0);
2121 if (ir->bDoAwh)
2123 ir->awhParams = gmx::readAwhParams(&inp, wi);
2126 /* Enforced rotation */
2127 printStringNewline(&inp, "ENFORCED ROTATION");
2128 printStringNoNewline(&inp, "Enforced rotation: No or Yes");
2129 ir->bRot = (get_eeenum(&inp, "rotation", yesno_names, wi) != 0);
2130 if (ir->bRot)
2132 snew(ir->rot, 1);
2133 inputrecStrings->rotateGroupNames = read_rotparams(&inp, ir->rot, wi);
2136 /* Interactive MD */
2137 ir->bIMD = FALSE;
2138 printStringNewline(&inp, "Group to display and/or manipulate in interactive MD session");
2139 setStringEntry(&inp, "IMD-group", inputrecStrings->imd_grp, nullptr);
2140 if (inputrecStrings->imd_grp[0] != '\0')
2142 snew(ir->imd, 1);
2143 ir->bIMD = TRUE;
2146 /* Refinement */
2147 printStringNewline(&inp, "NMR refinement stuff");
2148 printStringNoNewline(&inp, "Distance restraints type: No, Simple or Ensemble");
2149 ir->eDisre = get_eeenum(&inp, "disre", edisre_names, wi);
2150 printStringNoNewline(
2151 &inp, "Force weighting of pairs in one distance restraint: Conservative or Equal");
2152 ir->eDisreWeighting = get_eeenum(&inp, "disre-weighting", edisreweighting_names, wi);
2153 printStringNoNewline(&inp, "Use sqrt of the time averaged times the instantaneous violation");
2154 ir->bDisreMixed = (get_eeenum(&inp, "disre-mixed", yesno_names, wi) != 0);
2155 ir->dr_fc = get_ereal(&inp, "disre-fc", 1000.0, wi);
2156 ir->dr_tau = get_ereal(&inp, "disre-tau", 0.0, wi);
2157 printStringNoNewline(&inp, "Output frequency for pair distances to energy file");
2158 ir->nstdisreout = get_eint(&inp, "nstdisreout", 100, wi);
2159 printStringNoNewline(&inp, "Orientation restraints: No or Yes");
2160 opts->bOrire = (get_eeenum(&inp, "orire", yesno_names, wi) != 0);
2161 printStringNoNewline(&inp, "Orientation restraints force constant and tau for time averaging");
2162 ir->orires_fc = get_ereal(&inp, "orire-fc", 0.0, wi);
2163 ir->orires_tau = get_ereal(&inp, "orire-tau", 0.0, wi);
2164 setStringEntry(&inp, "orire-fitgrp", inputrecStrings->orirefitgrp, nullptr);
2165 printStringNoNewline(&inp, "Output frequency for trace(SD) and S to energy file");
2166 ir->nstorireout = get_eint(&inp, "nstorireout", 100, wi);
2168 /* free energy variables */
2169 printStringNewline(&inp, "Free energy variables");
2170 ir->efep = get_eeenum(&inp, "free-energy", efep_names, wi);
2171 setStringEntry(&inp, "couple-moltype", inputrecStrings->couple_moltype, nullptr);
2172 opts->couple_lam0 = get_eeenum(&inp, "couple-lambda0", couple_lam, wi);
2173 opts->couple_lam1 = get_eeenum(&inp, "couple-lambda1", couple_lam, wi);
2174 opts->bCoupleIntra = (get_eeenum(&inp, "couple-intramol", yesno_names, wi) != 0);
2176 fep->init_lambda = get_ereal(&inp, "init-lambda", -1, wi); /* start with -1 so
2177 we can recognize if
2178 it was not entered */
2179 fep->init_fep_state = get_eint(&inp, "init-lambda-state", -1, wi);
2180 fep->delta_lambda = get_ereal(&inp, "delta-lambda", 0.0, wi);
2181 fep->nstdhdl = get_eint(&inp, "nstdhdl", 50, wi);
2182 setStringEntry(&inp, "fep-lambdas", inputrecStrings->fep_lambda[efptFEP], nullptr);
2183 setStringEntry(&inp, "mass-lambdas", inputrecStrings->fep_lambda[efptMASS], nullptr);
2184 setStringEntry(&inp, "coul-lambdas", inputrecStrings->fep_lambda[efptCOUL], nullptr);
2185 setStringEntry(&inp, "vdw-lambdas", inputrecStrings->fep_lambda[efptVDW], nullptr);
2186 setStringEntry(&inp, "bonded-lambdas", inputrecStrings->fep_lambda[efptBONDED], nullptr);
2187 setStringEntry(&inp, "restraint-lambdas", inputrecStrings->fep_lambda[efptRESTRAINT], nullptr);
2188 setStringEntry(&inp, "temperature-lambdas", inputrecStrings->fep_lambda[efptTEMPERATURE], nullptr);
2189 fep->lambda_neighbors = get_eint(&inp, "calc-lambda-neighbors", 1, wi);
2190 setStringEntry(&inp, "init-lambda-weights", inputrecStrings->lambda_weights, nullptr);
2191 fep->edHdLPrintEnergy = get_eeenum(&inp, "dhdl-print-energy", edHdLPrintEnergy_names, wi);
2192 fep->sc_alpha = get_ereal(&inp, "sc-alpha", 0.0, wi);
2193 fep->sc_power = get_eint(&inp, "sc-power", 1, wi);
2194 fep->sc_r_power = get_ereal(&inp, "sc-r-power", 6.0, wi);
2195 fep->sc_sigma = get_ereal(&inp, "sc-sigma", 0.3, wi);
2196 fep->bScCoul = (get_eeenum(&inp, "sc-coul", yesno_names, wi) != 0);
2197 fep->dh_hist_size = get_eint(&inp, "dh_hist_size", 0, wi);
2198 fep->dh_hist_spacing = get_ereal(&inp, "dh_hist_spacing", 0.1, wi);
2199 fep->separate_dhdl_file = get_eeenum(&inp, "separate-dhdl-file", separate_dhdl_file_names, wi);
2200 fep->dhdl_derivatives = get_eeenum(&inp, "dhdl-derivatives", dhdl_derivatives_names, wi);
2201 fep->dh_hist_size = get_eint(&inp, "dh_hist_size", 0, wi);
2202 fep->dh_hist_spacing = get_ereal(&inp, "dh_hist_spacing", 0.1, wi);
2204 /* Non-equilibrium MD stuff */
2205 printStringNewline(&inp, "Non-equilibrium MD stuff");
2206 setStringEntry(&inp, "acc-grps", inputrecStrings->accgrps, nullptr);
2207 setStringEntry(&inp, "accelerate", inputrecStrings->acc, nullptr);
2208 setStringEntry(&inp, "freezegrps", inputrecStrings->freeze, nullptr);
2209 setStringEntry(&inp, "freezedim", inputrecStrings->frdim, nullptr);
2210 ir->cos_accel = get_ereal(&inp, "cos-acceleration", 0, wi);
2211 setStringEntry(&inp, "deform", inputrecStrings->deform, nullptr);
2213 /* simulated tempering variables */
2214 printStringNewline(&inp, "simulated tempering variables");
2215 ir->bSimTemp = (get_eeenum(&inp, "simulated-tempering", yesno_names, wi) != 0);
2216 ir->simtempvals->eSimTempScale = get_eeenum(&inp, "simulated-tempering-scaling", esimtemp_names, wi);
2217 ir->simtempvals->simtemp_low = get_ereal(&inp, "sim-temp-low", 300.0, wi);
2218 ir->simtempvals->simtemp_high = get_ereal(&inp, "sim-temp-high", 300.0, wi);
2220 /* expanded ensemble variables */
2221 if (ir->efep == efepEXPANDED || ir->bSimTemp)
2223 read_expandedparams(&inp, expand, wi);
2226 /* Electric fields */
2228 gmx::KeyValueTreeObject convertedValues = flatKeyValueTreeFromInpFile(inp);
2229 gmx::KeyValueTreeTransformer transform;
2230 transform.rules()->addRule().keyMatchType("/", gmx::StringCompareType::CaseAndDashInsensitive);
2231 mdModules->initMdpTransform(transform.rules());
2232 for (const auto& path : transform.mappedPaths())
2234 GMX_ASSERT(path.size() == 1, "Inconsistent mapping back to mdp options");
2235 mark_einp_set(inp, path[0].c_str());
2237 MdpErrorHandler errorHandler(wi);
2238 auto result = transform.transform(convertedValues, &errorHandler);
2239 ir->params = new gmx::KeyValueTreeObject(result.object());
2240 mdModules->adjustInputrecBasedOnModules(ir);
2241 errorHandler.setBackMapping(result.backMapping());
2242 mdModules->assignOptionsToModules(*ir->params, &errorHandler);
2245 /* Ion/water position swapping ("computational electrophysiology") */
2246 printStringNewline(&inp,
2247 "Ion/water position swapping for computational electrophysiology setups");
2248 printStringNoNewline(&inp, "Swap positions along direction: no, X, Y, Z");
2249 ir->eSwapCoords = get_eeenum(&inp, "swapcoords", eSwapTypes_names, wi);
2250 if (ir->eSwapCoords != eswapNO)
2252 char buf[STRLEN];
2253 int nIonTypes;
2256 snew(ir->swap, 1);
2257 printStringNoNewline(&inp, "Swap attempt frequency");
2258 ir->swap->nstswap = get_eint(&inp, "swap-frequency", 1, wi);
2259 printStringNoNewline(&inp, "Number of ion types to be controlled");
2260 nIonTypes = get_eint(&inp, "iontypes", 1, wi);
2261 if (nIonTypes < 1)
2263 warning_error(wi, "You need to provide at least one ion type for position exchanges.");
2265 ir->swap->ngrp = nIonTypes + eSwapFixedGrpNR;
2266 snew(ir->swap->grp, ir->swap->ngrp);
2267 for (i = 0; i < ir->swap->ngrp; i++)
2269 snew(ir->swap->grp[i].molname, STRLEN);
2271 printStringNoNewline(&inp,
2272 "Two index groups that contain the compartment-partitioning atoms");
2273 setStringEntry(&inp, "split-group0", ir->swap->grp[eGrpSplit0].molname, nullptr);
2274 setStringEntry(&inp, "split-group1", ir->swap->grp[eGrpSplit1].molname, nullptr);
2275 printStringNoNewline(&inp,
2276 "Use center of mass of split groups (yes/no), otherwise center of "
2277 "geometry is used");
2278 ir->swap->massw_split[0] = (get_eeenum(&inp, "massw-split0", yesno_names, wi) != 0);
2279 ir->swap->massw_split[1] = (get_eeenum(&inp, "massw-split1", yesno_names, wi) != 0);
2281 printStringNoNewline(&inp, "Name of solvent molecules");
2282 setStringEntry(&inp, "solvent-group", ir->swap->grp[eGrpSolvent].molname, nullptr);
2284 printStringNoNewline(&inp,
2285 "Split cylinder: radius, upper and lower extension (nm) (this will "
2286 "define the channels)");
2287 printStringNoNewline(&inp,
2288 "Note that the split cylinder settings do not have an influence on "
2289 "the swapping protocol,");
2290 printStringNoNewline(
2291 &inp,
2292 "however, if correctly defined, the permeation events are recorded per channel");
2293 ir->swap->cyl0r = get_ereal(&inp, "cyl0-r", 2.0, wi);
2294 ir->swap->cyl0u = get_ereal(&inp, "cyl0-up", 1.0, wi);
2295 ir->swap->cyl0l = get_ereal(&inp, "cyl0-down", 1.0, wi);
2296 ir->swap->cyl1r = get_ereal(&inp, "cyl1-r", 2.0, wi);
2297 ir->swap->cyl1u = get_ereal(&inp, "cyl1-up", 1.0, wi);
2298 ir->swap->cyl1l = get_ereal(&inp, "cyl1-down", 1.0, wi);
2300 printStringNoNewline(
2301 &inp,
2302 "Average the number of ions per compartment over these many swap attempt steps");
2303 ir->swap->nAverage = get_eint(&inp, "coupl-steps", 10, wi);
2305 printStringNoNewline(
2306 &inp, "Names of the ion types that can be exchanged with solvent molecules,");
2307 printStringNoNewline(
2308 &inp, "and the requested number of ions of this type in compartments A and B");
2309 printStringNoNewline(&inp, "-1 means fix the numbers as found in step 0");
2310 for (i = 0; i < nIonTypes; i++)
2312 int ig = eSwapFixedGrpNR + i;
2314 sprintf(buf, "iontype%d-name", i);
2315 setStringEntry(&inp, buf, ir->swap->grp[ig].molname, nullptr);
2316 sprintf(buf, "iontype%d-in-A", i);
2317 ir->swap->grp[ig].nmolReq[0] = get_eint(&inp, buf, -1, wi);
2318 sprintf(buf, "iontype%d-in-B", i);
2319 ir->swap->grp[ig].nmolReq[1] = get_eint(&inp, buf, -1, wi);
2322 printStringNoNewline(
2323 &inp,
2324 "By default (i.e. bulk offset = 0.0), ion/water exchanges happen between layers");
2325 printStringNoNewline(
2326 &inp,
2327 "at maximum distance (= bulk concentration) to the split group layers. However,");
2328 printStringNoNewline(&inp,
2329 "an offset b (-1.0 < b < +1.0) can be specified to offset the bulk "
2330 "layer from the middle at 0.0");
2331 printStringNoNewline(&inp,
2332 "towards one of the compartment-partitioning layers (at +/- 1.0).");
2333 ir->swap->bulkOffset[0] = get_ereal(&inp, "bulk-offsetA", 0.0, wi);
2334 ir->swap->bulkOffset[1] = get_ereal(&inp, "bulk-offsetB", 0.0, wi);
2335 if (!(ir->swap->bulkOffset[0] > -1.0 && ir->swap->bulkOffset[0] < 1.0)
2336 || !(ir->swap->bulkOffset[1] > -1.0 && ir->swap->bulkOffset[1] < 1.0))
2338 warning_error(wi, "Bulk layer offsets must be > -1.0 and < 1.0 !");
2341 printStringNoNewline(
2342 &inp, "Start to swap ions if threshold difference to requested count is reached");
2343 ir->swap->threshold = get_ereal(&inp, "threshold", 1.0, wi);
2346 /* AdResS is no longer supported, but we need grompp to be able to
2347 refuse to process old .mdp files that used it. */
2348 ir->bAdress = (get_eeenum(&inp, "adress", no_names, wi) != 0);
2350 /* User defined thingies */
2351 printStringNewline(&inp, "User defined thingies");
2352 setStringEntry(&inp, "user1-grps", inputrecStrings->user1, nullptr);
2353 setStringEntry(&inp, "user2-grps", inputrecStrings->user2, nullptr);
2354 ir->userint1 = get_eint(&inp, "userint1", 0, wi);
2355 ir->userint2 = get_eint(&inp, "userint2", 0, wi);
2356 ir->userint3 = get_eint(&inp, "userint3", 0, wi);
2357 ir->userint4 = get_eint(&inp, "userint4", 0, wi);
2358 ir->userreal1 = get_ereal(&inp, "userreal1", 0, wi);
2359 ir->userreal2 = get_ereal(&inp, "userreal2", 0, wi);
2360 ir->userreal3 = get_ereal(&inp, "userreal3", 0, wi);
2361 ir->userreal4 = get_ereal(&inp, "userreal4", 0, wi);
2362 #undef CTYPE
2365 gmx::TextOutputFile stream(mdparout);
2366 write_inpfile(&stream, mdparout, &inp, FALSE, writeMdpHeader, wi);
2368 // Transform module data into a flat key-value tree for output.
2369 gmx::KeyValueTreeBuilder builder;
2370 gmx::KeyValueTreeObjectBuilder builderObject = builder.rootObject();
2371 mdModules->buildMdpOutput(&builderObject);
2373 gmx::TextWriter writer(&stream);
2374 writeKeyValueTreeAsMdp(&writer, builder.build());
2376 stream.close();
2379 /* Process options if necessary */
2380 for (m = 0; m < 2; m++)
2382 for (i = 0; i < 2 * DIM; i++)
2384 dumdub[m][i] = 0.0;
2386 if (ir->epc)
2388 switch (ir->epct)
2390 case epctISOTROPIC:
2391 if (sscanf(dumstr[m], "%lf", &(dumdub[m][XX])) != 1)
2393 warning_error(
2395 "Pressure coupling incorrect number of values (I need exactly 1)");
2397 dumdub[m][YY] = dumdub[m][ZZ] = dumdub[m][XX];
2398 break;
2399 case epctSEMIISOTROPIC:
2400 case epctSURFACETENSION:
2401 if (sscanf(dumstr[m], "%lf%lf", &(dumdub[m][XX]), &(dumdub[m][ZZ])) != 2)
2403 warning_error(
2405 "Pressure coupling incorrect number of values (I need exactly 2)");
2407 dumdub[m][YY] = dumdub[m][XX];
2408 break;
2409 case epctANISOTROPIC:
2410 if (sscanf(dumstr[m], "%lf%lf%lf%lf%lf%lf", &(dumdub[m][XX]), &(dumdub[m][YY]),
2411 &(dumdub[m][ZZ]), &(dumdub[m][3]), &(dumdub[m][4]), &(dumdub[m][5]))
2412 != 6)
2414 warning_error(
2416 "Pressure coupling incorrect number of values (I need exactly 6)");
2418 break;
2419 default:
2420 gmx_fatal(FARGS, "Pressure coupling type %s not implemented yet",
2421 epcoupltype_names[ir->epct]);
2425 clear_mat(ir->ref_p);
2426 clear_mat(ir->compress);
2427 for (i = 0; i < DIM; i++)
2429 ir->ref_p[i][i] = dumdub[1][i];
2430 ir->compress[i][i] = dumdub[0][i];
2432 if (ir->epct == epctANISOTROPIC)
2434 ir->ref_p[XX][YY] = dumdub[1][3];
2435 ir->ref_p[XX][ZZ] = dumdub[1][4];
2436 ir->ref_p[YY][ZZ] = dumdub[1][5];
2437 if (ir->ref_p[XX][YY] != 0 && ir->ref_p[XX][ZZ] != 0 && ir->ref_p[YY][ZZ] != 0)
2439 warning(wi,
2440 "All off-diagonal reference pressures are non-zero. Are you sure you want to "
2441 "apply a threefold shear stress?\n");
2443 ir->compress[XX][YY] = dumdub[0][3];
2444 ir->compress[XX][ZZ] = dumdub[0][4];
2445 ir->compress[YY][ZZ] = dumdub[0][5];
2446 for (i = 0; i < DIM; i++)
2448 for (m = 0; m < i; m++)
2450 ir->ref_p[i][m] = ir->ref_p[m][i];
2451 ir->compress[i][m] = ir->compress[m][i];
2456 if (ir->comm_mode == ecmNO)
2458 ir->nstcomm = 0;
2461 opts->couple_moltype = nullptr;
2462 if (strlen(inputrecStrings->couple_moltype) > 0)
2464 if (ir->efep != efepNO)
2466 opts->couple_moltype = gmx_strdup(inputrecStrings->couple_moltype);
2467 if (opts->couple_lam0 == opts->couple_lam1)
2469 warning(wi, "The lambda=0 and lambda=1 states for coupling are identical");
2471 if (ir->eI == eiMD && (opts->couple_lam0 == ecouplamNONE || opts->couple_lam1 == ecouplamNONE))
2473 warning_note(
2475 "For proper sampling of the (nearly) decoupled state, stochastic dynamics "
2476 "should be used");
2479 else
2481 warning_note(wi,
2482 "Free energy is turned off, so we will not decouple the molecule listed "
2483 "in your input.");
2486 /* FREE ENERGY AND EXPANDED ENSEMBLE OPTIONS */
2487 if (ir->efep != efepNO)
2489 if (fep->delta_lambda > 0)
2491 ir->efep = efepSLOWGROWTH;
2495 if (fep->edHdLPrintEnergy == edHdLPrintEnergyYES)
2497 fep->edHdLPrintEnergy = edHdLPrintEnergyTOTAL;
2498 warning_note(wi,
2499 "Old option for dhdl-print-energy given: "
2500 "changing \"yes\" to \"total\"\n");
2503 if (ir->bSimTemp && (fep->edHdLPrintEnergy == edHdLPrintEnergyNO))
2505 /* always print out the energy to dhdl if we are doing
2506 expanded ensemble, since we need the total energy for
2507 analysis if the temperature is changing. In some
2508 conditions one may only want the potential energy, so
2509 we will allow that if the appropriate mdp setting has
2510 been enabled. Otherwise, total it is:
2512 fep->edHdLPrintEnergy = edHdLPrintEnergyTOTAL;
2515 if ((ir->efep != efepNO) || ir->bSimTemp)
2517 ir->bExpanded = FALSE;
2518 if ((ir->efep == efepEXPANDED) || ir->bSimTemp)
2520 ir->bExpanded = TRUE;
2522 do_fep_params(ir, inputrecStrings->fep_lambda, inputrecStrings->lambda_weights, wi);
2523 if (ir->bSimTemp) /* done after fep params */
2525 do_simtemp_params(ir);
2528 /* Because sc-coul (=FALSE by default) only acts on the lambda state
2529 * setup and not on the old way of specifying the free-energy setup,
2530 * we should check for using soft-core when not needed, since that
2531 * can complicate the sampling significantly.
2532 * Note that we only check for the automated coupling setup.
2533 * If the (advanced) user does FEP through manual topology changes,
2534 * this check will not be triggered.
2536 if (ir->efep != efepNO && ir->fepvals->n_lambda == 0 && ir->fepvals->sc_alpha != 0
2537 && (couple_lambda_has_vdw_on(opts->couple_lam0) && couple_lambda_has_vdw_on(opts->couple_lam1)))
2539 warning(wi,
2540 "You are using soft-core interactions while the Van der Waals interactions are "
2541 "not decoupled (note that the sc-coul option is only active when using lambda "
2542 "states). Although this will not lead to errors, you will need much more "
2543 "sampling than without soft-core interactions. Consider using sc-alpha=0.");
2546 else
2548 ir->fepvals->n_lambda = 0;
2551 /* WALL PARAMETERS */
2553 do_wall_params(ir, inputrecStrings->wall_atomtype, inputrecStrings->wall_density, opts, wi);
2555 /* ORIENTATION RESTRAINT PARAMETERS */
2557 if (opts->bOrire && gmx::splitString(inputrecStrings->orirefitgrp).size() != 1)
2559 warning_error(wi, "ERROR: Need one orientation restraint fit group\n");
2562 /* DEFORMATION PARAMETERS */
2564 clear_mat(ir->deform);
2565 for (i = 0; i < 6; i++)
2567 dumdub[0][i] = 0;
2570 double gmx_unused canary;
2571 int ndeform = sscanf(inputrecStrings->deform, "%lf %lf %lf %lf %lf %lf %lf", &(dumdub[0][0]),
2572 &(dumdub[0][1]), &(dumdub[0][2]), &(dumdub[0][3]), &(dumdub[0][4]),
2573 &(dumdub[0][5]), &canary);
2575 if (strlen(inputrecStrings->deform) > 0 && ndeform != 6)
2577 warning_error(wi,
2578 gmx::formatString(
2579 "Cannot parse exactly 6 box deformation velocities from string '%s'",
2580 inputrecStrings->deform)
2581 .c_str());
2583 for (i = 0; i < 3; i++)
2585 ir->deform[i][i] = dumdub[0][i];
2587 ir->deform[YY][XX] = dumdub[0][3];
2588 ir->deform[ZZ][XX] = dumdub[0][4];
2589 ir->deform[ZZ][YY] = dumdub[0][5];
2590 if (ir->epc != epcNO)
2592 for (i = 0; i < 3; i++)
2594 for (j = 0; j <= i; j++)
2596 if (ir->deform[i][j] != 0 && ir->compress[i][j] != 0)
2598 warning_error(wi, "A box element has deform set and compressibility > 0");
2602 for (i = 0; i < 3; i++)
2604 for (j = 0; j < i; j++)
2606 if (ir->deform[i][j] != 0)
2608 for (m = j; m < DIM; m++)
2610 if (ir->compress[m][j] != 0)
2612 sprintf(warn_buf,
2613 "An off-diagonal box element has deform set while "
2614 "compressibility > 0 for the same component of another box "
2615 "vector, this might lead to spurious periodicity effects.");
2616 warning(wi, warn_buf);
2624 /* Ion/water position swapping checks */
2625 if (ir->eSwapCoords != eswapNO)
2627 if (ir->swap->nstswap < 1)
2629 warning_error(wi, "swap_frequency must be 1 or larger when ion swapping is requested");
2631 if (ir->swap->nAverage < 1)
2633 warning_error(wi, "coupl_steps must be 1 or larger.\n");
2635 if (ir->swap->threshold < 1.0)
2637 warning_error(wi, "Ion count threshold must be at least 1.\n");
2641 if (ir->bDoAwh)
2643 gmx::checkAwhParams(ir->awhParams, ir, wi);
2646 sfree(dumstr[0]);
2647 sfree(dumstr[1]);
2650 /* We would like gn to be const as well, but C doesn't allow this */
2651 /* TODO this is utility functionality (search for the index of a
2652 string in a collection), so should be refactored and located more
2653 centrally. */
2654 int search_string(const char* s, int ng, char* gn[])
2656 int i;
2658 for (i = 0; (i < ng); i++)
2660 if (gmx_strcasecmp(s, gn[i]) == 0)
2662 return i;
2666 gmx_fatal(FARGS,
2667 "Group %s referenced in the .mdp file was not found in the index file.\n"
2668 "Group names must match either [moleculetype] names or custom index group\n"
2669 "names, in which case you must supply an index file to the '-n' option\n"
2670 "of grompp.",
2674 static void do_numbering(int natoms,
2675 SimulationGroups* groups,
2676 gmx::ArrayRef<std::string> groupsFromMdpFile,
2677 t_blocka* block,
2678 char* gnames[],
2679 SimulationAtomGroupType gtype,
2680 int restnm,
2681 int grptp,
2682 bool bVerbose,
2683 warninp_t wi)
2685 unsigned short* cbuf;
2686 AtomGroupIndices* grps = &(groups->groups[gtype]);
2687 int j, gid, aj, ognr, ntot = 0;
2688 const char* title;
2689 char warn_buf[STRLEN];
2691 title = shortName(gtype);
2693 snew(cbuf, natoms);
2694 /* Mark all id's as not set */
2695 for (int i = 0; (i < natoms); i++)
2697 cbuf[i] = NOGID;
2700 for (int i = 0; i != groupsFromMdpFile.ssize(); ++i)
2702 /* Lookup the group name in the block structure */
2703 gid = search_string(groupsFromMdpFile[i].c_str(), block->nr, gnames);
2704 if ((grptp != egrptpONE) || (i == 0))
2706 grps->emplace_back(gid);
2709 /* Now go over the atoms in the group */
2710 for (j = block->index[gid]; (j < block->index[gid + 1]); j++)
2713 aj = block->a[j];
2715 /* Range checking */
2716 if ((aj < 0) || (aj >= natoms))
2718 gmx_fatal(FARGS, "Invalid atom number %d in indexfile", aj + 1);
2720 /* Lookup up the old group number */
2721 ognr = cbuf[aj];
2722 if (ognr != NOGID)
2724 gmx_fatal(FARGS, "Atom %d in multiple %s groups (%d and %d)", aj + 1, title,
2725 ognr + 1, i + 1);
2727 else
2729 /* Store the group number in buffer */
2730 if (grptp == egrptpONE)
2732 cbuf[aj] = 0;
2734 else
2736 cbuf[aj] = i;
2738 ntot++;
2743 /* Now check whether we have done all atoms */
2744 if (ntot != natoms)
2746 if (grptp == egrptpALL)
2748 gmx_fatal(FARGS, "%d atoms are not part of any of the %s groups", natoms - ntot, title);
2750 else if (grptp == egrptpPART)
2752 sprintf(warn_buf, "%d atoms are not part of any of the %s groups", natoms - ntot, title);
2753 warning_note(wi, warn_buf);
2755 /* Assign all atoms currently unassigned to a rest group */
2756 for (j = 0; (j < natoms); j++)
2758 if (cbuf[j] == NOGID)
2760 cbuf[j] = grps->size();
2763 if (grptp != egrptpPART)
2765 if (bVerbose)
2767 fprintf(stderr, "Making dummy/rest group for %s containing %d elements\n", title,
2768 natoms - ntot);
2770 /* Add group name "rest" */
2771 grps->emplace_back(restnm);
2773 /* Assign the rest name to all atoms not currently assigned to a group */
2774 for (j = 0; (j < natoms); j++)
2776 if (cbuf[j] == NOGID)
2778 // group size was not updated before this here, so need to use -1.
2779 cbuf[j] = grps->size() - 1;
2785 if (grps->size() == 1 && (ntot == 0 || ntot == natoms))
2787 /* All atoms are part of one (or no) group, no index required */
2788 groups->groupNumbers[gtype].clear();
2790 else
2792 for (int j = 0; (j < natoms); j++)
2794 groups->groupNumbers[gtype].emplace_back(cbuf[j]);
2798 sfree(cbuf);
2801 static void calc_nrdf(const gmx_mtop_t* mtop, t_inputrec* ir, char** gnames)
2803 t_grpopts* opts;
2804 pull_params_t* pull;
2805 int natoms, imin, jmin;
2806 int * nrdf2, *na_vcm, na_tot;
2807 double * nrdf_tc, *nrdf_vcm, nrdf_uc, *nrdf_vcm_sub;
2808 ivec* dof_vcm;
2809 int as;
2811 /* Calculate nrdf.
2812 * First calc 3xnr-atoms for each group
2813 * then subtract half a degree of freedom for each constraint
2815 * Only atoms and nuclei contribute to the degrees of freedom...
2818 opts = &ir->opts;
2820 const SimulationGroups& groups = mtop->groups;
2821 natoms = mtop->natoms;
2823 /* Allocate one more for a possible rest group */
2824 /* We need to sum degrees of freedom into doubles,
2825 * since floats give too low nrdf's above 3 million atoms.
2827 snew(nrdf_tc, groups.groups[SimulationAtomGroupType::TemperatureCoupling].size() + 1);
2828 snew(nrdf_vcm, groups.groups[SimulationAtomGroupType::MassCenterVelocityRemoval].size() + 1);
2829 snew(dof_vcm, groups.groups[SimulationAtomGroupType::MassCenterVelocityRemoval].size() + 1);
2830 snew(na_vcm, groups.groups[SimulationAtomGroupType::MassCenterVelocityRemoval].size() + 1);
2831 snew(nrdf_vcm_sub, groups.groups[SimulationAtomGroupType::MassCenterVelocityRemoval].size() + 1);
2833 for (gmx::index i = 0; i < gmx::ssize(groups.groups[SimulationAtomGroupType::TemperatureCoupling]); i++)
2835 nrdf_tc[i] = 0;
2837 for (gmx::index i = 0;
2838 i < gmx::ssize(groups.groups[SimulationAtomGroupType::MassCenterVelocityRemoval]) + 1; i++)
2840 nrdf_vcm[i] = 0;
2841 clear_ivec(dof_vcm[i]);
2842 na_vcm[i] = 0;
2843 nrdf_vcm_sub[i] = 0;
2845 snew(nrdf2, natoms);
2846 for (const AtomProxy atomP : AtomRange(*mtop))
2848 const t_atom& local = atomP.atom();
2849 int i = atomP.globalAtomNumber();
2850 nrdf2[i] = 0;
2851 if (local.ptype == eptAtom || local.ptype == eptNucleus)
2853 int g = getGroupType(groups, SimulationAtomGroupType::Freeze, i);
2854 for (int d = 0; d < DIM; d++)
2856 if (opts->nFreeze[g][d] == 0)
2858 /* Add one DOF for particle i (counted as 2*1) */
2859 nrdf2[i] += 2;
2860 /* VCM group i has dim d as a DOF */
2861 dof_vcm[getGroupType(groups, SimulationAtomGroupType::MassCenterVelocityRemoval, i)][d] =
2865 nrdf_tc[getGroupType(groups, SimulationAtomGroupType::TemperatureCoupling, i)] +=
2866 0.5 * nrdf2[i];
2867 nrdf_vcm[getGroupType(groups, SimulationAtomGroupType::MassCenterVelocityRemoval, i)] +=
2868 0.5 * nrdf2[i];
2872 as = 0;
2873 for (const gmx_molblock_t& molb : mtop->molblock)
2875 const gmx_moltype_t& molt = mtop->moltype[molb.type];
2876 const t_atom* atom = molt.atoms.atom;
2877 for (int mol = 0; mol < molb.nmol; mol++)
2879 for (int ftype = F_CONSTR; ftype <= F_CONSTRNC; ftype++)
2881 gmx::ArrayRef<const int> ia = molt.ilist[ftype].iatoms;
2882 for (int i = 0; i < molt.ilist[ftype].size();)
2884 /* Subtract degrees of freedom for the constraints,
2885 * if the particles still have degrees of freedom left.
2886 * If one of the particles is a vsite or a shell, then all
2887 * constraint motion will go there, but since they do not
2888 * contribute to the constraints the degrees of freedom do not
2889 * change.
2891 int ai = as + ia[i + 1];
2892 int aj = as + ia[i + 2];
2893 if (((atom[ia[i + 1]].ptype == eptNucleus) || (atom[ia[i + 1]].ptype == eptAtom))
2894 && ((atom[ia[i + 2]].ptype == eptNucleus) || (atom[ia[i + 2]].ptype == eptAtom)))
2896 if (nrdf2[ai] > 0)
2898 jmin = 1;
2900 else
2902 jmin = 2;
2904 if (nrdf2[aj] > 0)
2906 imin = 1;
2908 else
2910 imin = 2;
2912 imin = std::min(imin, nrdf2[ai]);
2913 jmin = std::min(jmin, nrdf2[aj]);
2914 nrdf2[ai] -= imin;
2915 nrdf2[aj] -= jmin;
2916 nrdf_tc[getGroupType(groups, SimulationAtomGroupType::TemperatureCoupling, ai)] -=
2917 0.5 * imin;
2918 nrdf_tc[getGroupType(groups, SimulationAtomGroupType::TemperatureCoupling, aj)] -=
2919 0.5 * jmin;
2920 nrdf_vcm[getGroupType(groups, SimulationAtomGroupType::MassCenterVelocityRemoval, ai)] -=
2921 0.5 * imin;
2922 nrdf_vcm[getGroupType(groups, SimulationAtomGroupType::MassCenterVelocityRemoval, aj)] -=
2923 0.5 * jmin;
2925 i += interaction_function[ftype].nratoms + 1;
2928 gmx::ArrayRef<const int> ia = molt.ilist[F_SETTLE].iatoms;
2929 for (int i = 0; i < molt.ilist[F_SETTLE].size();)
2931 /* Subtract 1 dof from every atom in the SETTLE */
2932 for (int j = 0; j < 3; j++)
2934 int ai = as + ia[i + 1 + j];
2935 imin = std::min(2, nrdf2[ai]);
2936 nrdf2[ai] -= imin;
2937 nrdf_tc[getGroupType(groups, SimulationAtomGroupType::TemperatureCoupling, ai)] -=
2938 0.5 * imin;
2939 nrdf_vcm[getGroupType(groups, SimulationAtomGroupType::MassCenterVelocityRemoval, ai)] -=
2940 0.5 * imin;
2942 i += 4;
2944 as += molt.atoms.nr;
2948 if (ir->bPull)
2950 /* Correct nrdf for the COM constraints.
2951 * We correct using the TC and VCM group of the first atom
2952 * in the reference and pull group. If atoms in one pull group
2953 * belong to different TC or VCM groups it is anyhow difficult
2954 * to determine the optimal nrdf assignment.
2956 pull = ir->pull;
2958 for (int i = 0; i < pull->ncoord; i++)
2960 if (pull->coord[i].eType != epullCONSTRAINT)
2962 continue;
2965 imin = 1;
2967 for (int j = 0; j < 2; j++)
2969 const t_pull_group* pgrp;
2971 pgrp = &pull->group[pull->coord[i].group[j]];
2973 if (pgrp->nat > 0)
2975 /* Subtract 1/2 dof from each group */
2976 int ai = pgrp->ind[0];
2977 nrdf_tc[getGroupType(groups, SimulationAtomGroupType::TemperatureCoupling, ai)] -=
2978 0.5 * imin;
2979 nrdf_vcm[getGroupType(groups, SimulationAtomGroupType::MassCenterVelocityRemoval, ai)] -=
2980 0.5 * imin;
2981 if (nrdf_tc[getGroupType(groups, SimulationAtomGroupType::TemperatureCoupling, ai)] < 0)
2983 gmx_fatal(FARGS,
2984 "Center of mass pulling constraints caused the number of degrees "
2985 "of freedom for temperature coupling group %s to be negative",
2986 gnames[groups.groups[SimulationAtomGroupType::TemperatureCoupling][getGroupType(
2987 groups, SimulationAtomGroupType::TemperatureCoupling, ai)]]);
2990 else
2992 /* We need to subtract the whole DOF from group j=1 */
2993 imin += 1;
2999 if (ir->nstcomm != 0)
3001 GMX_RELEASE_ASSERT(!groups.groups[SimulationAtomGroupType::MassCenterVelocityRemoval].empty(),
3002 "Expect at least one group when removing COM motion");
3004 /* We remove COM motion up to dim ndof_com() */
3005 const int ndim_rm_vcm = ndof_com(ir);
3007 /* Subtract ndim_rm_vcm (or less with frozen dimensions) from
3008 * the number of degrees of freedom in each vcm group when COM
3009 * translation is removed and 6 when rotation is removed as well.
3010 * Note that we do not and should not include the rest group here.
3012 for (gmx::index j = 0;
3013 j < gmx::ssize(groups.groups[SimulationAtomGroupType::MassCenterVelocityRemoval]); j++)
3015 switch (ir->comm_mode)
3017 case ecmLINEAR:
3018 case ecmLINEAR_ACCELERATION_CORRECTION:
3019 nrdf_vcm_sub[j] = 0;
3020 for (int d = 0; d < ndim_rm_vcm; d++)
3022 if (dof_vcm[j][d])
3024 nrdf_vcm_sub[j]++;
3027 break;
3028 case ecmANGULAR: nrdf_vcm_sub[j] = 6; break;
3029 default: gmx_incons("Checking comm_mode");
3033 for (gmx::index i = 0;
3034 i < gmx::ssize(groups.groups[SimulationAtomGroupType::TemperatureCoupling]); i++)
3036 /* Count the number of atoms of TC group i for every VCM group */
3037 for (gmx::index j = 0;
3038 j < gmx::ssize(groups.groups[SimulationAtomGroupType::MassCenterVelocityRemoval]) + 1; j++)
3040 na_vcm[j] = 0;
3042 na_tot = 0;
3043 for (int ai = 0; ai < natoms; ai++)
3045 if (getGroupType(groups, SimulationAtomGroupType::TemperatureCoupling, ai) == i)
3047 na_vcm[getGroupType(groups, SimulationAtomGroupType::MassCenterVelocityRemoval, ai)]++;
3048 na_tot++;
3051 /* Correct for VCM removal according to the fraction of each VCM
3052 * group present in this TC group.
3054 nrdf_uc = nrdf_tc[i];
3055 nrdf_tc[i] = 0;
3056 for (gmx::index j = 0;
3057 j < gmx::ssize(groups.groups[SimulationAtomGroupType::MassCenterVelocityRemoval]) + 1; j++)
3059 if (nrdf_vcm[j] > nrdf_vcm_sub[j])
3061 nrdf_tc[i] += nrdf_uc * (static_cast<double>(na_vcm[j]) / static_cast<double>(na_tot))
3062 * (nrdf_vcm[j] - nrdf_vcm_sub[j]) / nrdf_vcm[j];
3067 for (int i = 0; (i < gmx::ssize(groups.groups[SimulationAtomGroupType::TemperatureCoupling])); i++)
3069 opts->nrdf[i] = nrdf_tc[i];
3070 if (opts->nrdf[i] < 0)
3072 opts->nrdf[i] = 0;
3074 fprintf(stderr, "Number of degrees of freedom in T-Coupling group %s is %.2f\n",
3075 gnames[groups.groups[SimulationAtomGroupType::TemperatureCoupling][i]], opts->nrdf[i]);
3078 sfree(nrdf2);
3079 sfree(nrdf_tc);
3080 sfree(nrdf_vcm);
3081 sfree(dof_vcm);
3082 sfree(na_vcm);
3083 sfree(nrdf_vcm_sub);
3086 static bool do_egp_flag(t_inputrec* ir, SimulationGroups* groups, const char* option, const char* val, int flag)
3088 /* The maximum number of energy group pairs would be MAXPTR*(MAXPTR+1)/2.
3089 * But since this is much larger than STRLEN, such a line can not be parsed.
3090 * The real maximum is the number of names that fit in a string: STRLEN/2.
3092 #define EGP_MAX (STRLEN / 2)
3093 int j, k, nr;
3094 bool bSet;
3096 auto names = gmx::splitString(val);
3097 if (names.size() % 2 != 0)
3099 gmx_fatal(FARGS, "The number of groups for %s is odd", option);
3101 nr = groups->groups[SimulationAtomGroupType::EnergyOutput].size();
3102 bSet = FALSE;
3103 for (size_t i = 0; i < names.size() / 2; i++)
3105 // TODO this needs to be replaced by a solution using std::find_if
3106 j = 0;
3107 while ((j < nr)
3108 && gmx_strcasecmp(
3109 names[2 * i].c_str(),
3110 *(groups->groupNames[groups->groups[SimulationAtomGroupType::EnergyOutput][j]])))
3112 j++;
3114 if (j == nr)
3116 gmx_fatal(FARGS, "%s in %s is not an energy group\n", names[2 * i].c_str(), option);
3118 k = 0;
3119 while ((k < nr)
3120 && gmx_strcasecmp(
3121 names[2 * i + 1].c_str(),
3122 *(groups->groupNames[groups->groups[SimulationAtomGroupType::EnergyOutput][k]])))
3124 k++;
3126 if (k == nr)
3128 gmx_fatal(FARGS, "%s in %s is not an energy group\n", names[2 * i + 1].c_str(), option);
3130 if ((j < nr) && (k < nr))
3132 ir->opts.egp_flags[nr * j + k] |= flag;
3133 ir->opts.egp_flags[nr * k + j] |= flag;
3134 bSet = TRUE;
3138 return bSet;
3142 static void make_swap_groups(t_swapcoords* swap, t_blocka* grps, char** gnames)
3144 int ig = -1, i = 0, gind;
3145 t_swapGroup* swapg;
3148 /* Just a quick check here, more thorough checks are in mdrun */
3149 if (strcmp(swap->grp[eGrpSplit0].molname, swap->grp[eGrpSplit1].molname) == 0)
3151 gmx_fatal(FARGS, "The split groups can not both be '%s'.", swap->grp[eGrpSplit0].molname);
3154 /* Get the index atoms of the split0, split1, solvent, and swap groups */
3155 for (ig = 0; ig < swap->ngrp; ig++)
3157 swapg = &swap->grp[ig];
3158 gind = search_string(swap->grp[ig].molname, grps->nr, gnames);
3159 swapg->nat = grps->index[gind + 1] - grps->index[gind];
3161 if (swapg->nat > 0)
3163 fprintf(stderr, "%s group '%s' contains %d atoms.\n",
3164 ig < 3 ? eSwapFixedGrp_names[ig] : "Swap", swap->grp[ig].molname, swapg->nat);
3165 snew(swapg->ind, swapg->nat);
3166 for (i = 0; i < swapg->nat; i++)
3168 swapg->ind[i] = grps->a[grps->index[gind] + i];
3171 else
3173 gmx_fatal(FARGS, "Swap group %s does not contain any atoms.", swap->grp[ig].molname);
3179 static void make_IMD_group(t_IMD* IMDgroup, char* IMDgname, t_blocka* grps, char** gnames)
3181 int ig, i;
3184 ig = search_string(IMDgname, grps->nr, gnames);
3185 IMDgroup->nat = grps->index[ig + 1] - grps->index[ig];
3187 if (IMDgroup->nat > 0)
3189 fprintf(stderr,
3190 "Group '%s' with %d atoms can be activated for interactive molecular dynamics "
3191 "(IMD).\n",
3192 IMDgname, IMDgroup->nat);
3193 snew(IMDgroup->ind, IMDgroup->nat);
3194 for (i = 0; i < IMDgroup->nat; i++)
3196 IMDgroup->ind[i] = grps->a[grps->index[ig] + i];
3201 /* Checks whether atoms are both part of a COM removal group and frozen.
3202 * If a fully frozen atom is part of a COM removal group, it is removed
3203 * from the COM removal group. A note is issued if such atoms are present.
3204 * A warning is issued for atom with one or two dimensions frozen that
3205 * are part of a COM removal group (mdrun would need to compute COM mass
3206 * per dimension to handle this correctly).
3207 * Also issues a warning when non-frozen atoms are not part of a COM
3208 * removal group while COM removal is active.
3210 static void checkAndUpdateVcmFreezeGroupConsistency(SimulationGroups* groups,
3211 const int numAtoms,
3212 const t_grpopts& opts,
3213 warninp_t wi)
3215 const int vcmRestGroup =
3216 std::max(int(groups->groups[SimulationAtomGroupType::MassCenterVelocityRemoval].size()), 1);
3218 int numFullyFrozenVcmAtoms = 0;
3219 int numPartiallyFrozenVcmAtoms = 0;
3220 int numNonVcmAtoms = 0;
3221 for (int a = 0; a < numAtoms; a++)
3223 const int freezeGroup = getGroupType(*groups, SimulationAtomGroupType::Freeze, a);
3224 int numFrozenDims = 0;
3225 for (int d = 0; d < DIM; d++)
3227 numFrozenDims += opts.nFreeze[freezeGroup][d];
3230 const int vcmGroup = getGroupType(*groups, SimulationAtomGroupType::MassCenterVelocityRemoval, a);
3231 if (vcmGroup < vcmRestGroup)
3233 if (numFrozenDims == DIM)
3235 /* Do not remove COM motion for this fully frozen atom */
3236 if (groups->groups[SimulationAtomGroupType::MassCenterVelocityRemoval].empty())
3238 groups->groups[SimulationAtomGroupType::MassCenterVelocityRemoval].resize(numAtoms, 0);
3240 groups->groups[SimulationAtomGroupType::MassCenterVelocityRemoval][a] = vcmRestGroup;
3241 numFullyFrozenVcmAtoms++;
3243 else if (numFrozenDims > 0)
3245 numPartiallyFrozenVcmAtoms++;
3248 else if (numFrozenDims < DIM)
3250 numNonVcmAtoms++;
3254 if (numFullyFrozenVcmAtoms > 0)
3256 std::string warningText = gmx::formatString(
3257 "There are %d atoms that are fully frozen and part of COMM removal group(s), "
3258 "removing these atoms from the COMM removal group(s)",
3259 numFullyFrozenVcmAtoms);
3260 warning_note(wi, warningText.c_str());
3262 if (numPartiallyFrozenVcmAtoms > 0 && numPartiallyFrozenVcmAtoms < numAtoms)
3264 std::string warningText = gmx::formatString(
3265 "There are %d atoms that are frozen along less then %d dimensions and part of COMM "
3266 "removal group(s), due to limitations in the code these still contribute to the "
3267 "mass of the COM along frozen dimensions and therefore the COMM correction will be "
3268 "too small.",
3269 numPartiallyFrozenVcmAtoms, DIM);
3270 warning(wi, warningText.c_str());
3272 if (numNonVcmAtoms > 0)
3274 std::string warningText = gmx::formatString(
3275 "%d atoms are not part of any center of mass motion removal group.\n"
3276 "This may lead to artifacts.\n"
3277 "In most cases one should use one group for the whole system.",
3278 numNonVcmAtoms);
3279 warning(wi, warningText.c_str());
3283 void do_index(const char* mdparin,
3284 const char* ndx,
3285 gmx_mtop_t* mtop,
3286 bool bVerbose,
3287 const gmx::MdModulesNotifier& notifier,
3288 t_inputrec* ir,
3289 warninp_t wi)
3291 t_blocka* defaultIndexGroups;
3292 int natoms;
3293 t_symtab* symtab;
3294 t_atoms atoms_all;
3295 char** gnames;
3296 int nr;
3297 real tau_min;
3298 int nstcmin;
3299 int i, j, k, restnm;
3300 bool bExcl, bTable, bAnneal;
3301 char warn_buf[STRLEN];
3303 if (bVerbose)
3305 fprintf(stderr, "processing index file...\n");
3307 if (ndx == nullptr)
3309 snew(defaultIndexGroups, 1);
3310 snew(defaultIndexGroups->index, 1);
3311 snew(gnames, 1);
3312 atoms_all = gmx_mtop_global_atoms(mtop);
3313 analyse(&atoms_all, defaultIndexGroups, &gnames, FALSE, TRUE);
3314 done_atom(&atoms_all);
3316 else
3318 defaultIndexGroups = init_index(ndx, &gnames);
3321 SimulationGroups* groups = &mtop->groups;
3322 natoms = mtop->natoms;
3323 symtab = &mtop->symtab;
3325 for (int i = 0; (i < defaultIndexGroups->nr); i++)
3327 groups->groupNames.emplace_back(put_symtab(symtab, gnames[i]));
3329 groups->groupNames.emplace_back(put_symtab(symtab, "rest"));
3330 restnm = groups->groupNames.size() - 1;
3331 GMX_RELEASE_ASSERT(restnm == defaultIndexGroups->nr, "Size of allocations must match");
3332 srenew(gnames, defaultIndexGroups->nr + 1);
3333 gnames[restnm] = *(groups->groupNames.back());
3335 set_warning_line(wi, mdparin, -1);
3337 auto temperatureCouplingTauValues = gmx::splitString(inputrecStrings->tau_t);
3338 auto temperatureCouplingReferenceValues = gmx::splitString(inputrecStrings->ref_t);
3339 auto temperatureCouplingGroupNames = gmx::splitString(inputrecStrings->tcgrps);
3340 if (temperatureCouplingTauValues.size() != temperatureCouplingGroupNames.size()
3341 || temperatureCouplingReferenceValues.size() != temperatureCouplingGroupNames.size())
3343 gmx_fatal(FARGS,
3344 "Invalid T coupling input: %zu groups, %zu ref-t values and "
3345 "%zu tau-t values",
3346 temperatureCouplingGroupNames.size(), temperatureCouplingReferenceValues.size(),
3347 temperatureCouplingTauValues.size());
3350 const bool useReferenceTemperature = integratorHasReferenceTemperature(ir);
3351 do_numbering(natoms, groups, temperatureCouplingGroupNames, defaultIndexGroups, gnames,
3352 SimulationAtomGroupType::TemperatureCoupling, restnm,
3353 useReferenceTemperature ? egrptpALL : egrptpALL_GENREST, bVerbose, wi);
3354 nr = groups->groups[SimulationAtomGroupType::TemperatureCoupling].size();
3355 ir->opts.ngtc = nr;
3356 snew(ir->opts.nrdf, nr);
3357 snew(ir->opts.tau_t, nr);
3358 snew(ir->opts.ref_t, nr);
3359 if (ir->eI == eiBD && ir->bd_fric == 0)
3361 fprintf(stderr, "bd-fric=0, so tau-t will be used as the inverse friction constant(s)\n");
3364 if (useReferenceTemperature)
3366 if (size_t(nr) != temperatureCouplingReferenceValues.size())
3368 gmx_fatal(FARGS, "Not enough ref-t and tau-t values!");
3371 tau_min = 1e20;
3372 convertReals(wi, temperatureCouplingTauValues, "tau-t", ir->opts.tau_t);
3373 for (i = 0; (i < nr); i++)
3375 if ((ir->eI == eiBD) && ir->opts.tau_t[i] <= 0)
3377 sprintf(warn_buf, "With integrator %s tau-t should be larger than 0", ei_names[ir->eI]);
3378 warning_error(wi, warn_buf);
3381 if (ir->etc != etcVRESCALE && ir->opts.tau_t[i] == 0)
3383 warning_note(
3385 "tau-t = -1 is the value to signal that a group should not have "
3386 "temperature coupling. Treating your use of tau-t = 0 as if you used -1.");
3389 if (ir->opts.tau_t[i] >= 0)
3391 tau_min = std::min(tau_min, ir->opts.tau_t[i]);
3394 if (ir->etc != etcNO && ir->nsttcouple == -1)
3396 ir->nsttcouple = ir_optimal_nsttcouple(ir);
3399 if (EI_VV(ir->eI))
3401 if ((ir->etc == etcNOSEHOOVER) && (ir->epc == epcBERENDSEN))
3403 gmx_fatal(FARGS,
3404 "Cannot do Nose-Hoover temperature with Berendsen pressure control with "
3405 "md-vv; use either vrescale temperature with berendsen pressure or "
3406 "Nose-Hoover temperature with MTTK pressure");
3408 if (ir->epc == epcMTTK)
3410 if (ir->etc != etcNOSEHOOVER)
3412 gmx_fatal(FARGS,
3413 "Cannot do MTTK pressure coupling without Nose-Hoover temperature "
3414 "control");
3416 else
3418 if (ir->nstpcouple != ir->nsttcouple)
3420 int mincouple = std::min(ir->nstpcouple, ir->nsttcouple);
3421 ir->nstpcouple = ir->nsttcouple = mincouple;
3422 sprintf(warn_buf,
3423 "for current Trotter decomposition methods with vv, nsttcouple and "
3424 "nstpcouple must be equal. Both have been reset to "
3425 "min(nsttcouple,nstpcouple) = %d",
3426 mincouple);
3427 warning_note(wi, warn_buf);
3432 /* velocity verlet with averaged kinetic energy KE = 0.5*(v(t+1/2) - v(t-1/2)) is implemented
3433 primarily for testing purposes, and does not work with temperature coupling other than 1 */
3435 if (ETC_ANDERSEN(ir->etc))
3437 if (ir->nsttcouple != 1)
3439 ir->nsttcouple = 1;
3440 sprintf(warn_buf,
3441 "Andersen temperature control methods assume nsttcouple = 1; there is no "
3442 "need for larger nsttcouple > 1, since no global parameters are computed. "
3443 "nsttcouple has been reset to 1");
3444 warning_note(wi, warn_buf);
3447 nstcmin = tcouple_min_integration_steps(ir->etc);
3448 if (nstcmin > 1)
3450 if (tau_min / (ir->delta_t * ir->nsttcouple) < nstcmin - 10 * GMX_REAL_EPS)
3452 sprintf(warn_buf,
3453 "For proper integration of the %s thermostat, tau-t (%g) should be at "
3454 "least %d times larger than nsttcouple*dt (%g)",
3455 ETCOUPLTYPE(ir->etc), tau_min, nstcmin, ir->nsttcouple * ir->delta_t);
3456 warning(wi, warn_buf);
3459 convertReals(wi, temperatureCouplingReferenceValues, "ref-t", ir->opts.ref_t);
3460 for (i = 0; (i < nr); i++)
3462 if (ir->opts.ref_t[i] < 0)
3464 gmx_fatal(FARGS, "ref-t for group %d negative", i);
3467 /* set the lambda mc temperature to the md integrator temperature (which should be defined
3468 if we are in this conditional) if mc_temp is negative */
3469 if (ir->expandedvals->mc_temp < 0)
3471 ir->expandedvals->mc_temp = ir->opts.ref_t[0]; /*for now, set to the first reft */
3475 /* Simulated annealing for each group. There are nr groups */
3476 auto simulatedAnnealingGroupNames = gmx::splitString(inputrecStrings->anneal);
3477 if (simulatedAnnealingGroupNames.size() == 1
3478 && gmx::equalCaseInsensitive(simulatedAnnealingGroupNames[0], "N", 1))
3480 simulatedAnnealingGroupNames.resize(0);
3482 if (!simulatedAnnealingGroupNames.empty() && gmx::ssize(simulatedAnnealingGroupNames) != nr)
3484 gmx_fatal(FARGS, "Wrong number of annealing values: %zu (for %d groups)\n",
3485 simulatedAnnealingGroupNames.size(), nr);
3487 else
3489 snew(ir->opts.annealing, nr);
3490 snew(ir->opts.anneal_npoints, nr);
3491 snew(ir->opts.anneal_time, nr);
3492 snew(ir->opts.anneal_temp, nr);
3493 for (i = 0; i < nr; i++)
3495 ir->opts.annealing[i] = eannNO;
3496 ir->opts.anneal_npoints[i] = 0;
3497 ir->opts.anneal_time[i] = nullptr;
3498 ir->opts.anneal_temp[i] = nullptr;
3500 if (!simulatedAnnealingGroupNames.empty())
3502 bAnneal = FALSE;
3503 for (i = 0; i < nr; i++)
3505 if (gmx::equalCaseInsensitive(simulatedAnnealingGroupNames[i], "N", 1))
3507 ir->opts.annealing[i] = eannNO;
3509 else if (gmx::equalCaseInsensitive(simulatedAnnealingGroupNames[i], "S", 1))
3511 ir->opts.annealing[i] = eannSINGLE;
3512 bAnneal = TRUE;
3514 else if (gmx::equalCaseInsensitive(simulatedAnnealingGroupNames[i], "P", 1))
3516 ir->opts.annealing[i] = eannPERIODIC;
3517 bAnneal = TRUE;
3520 if (bAnneal)
3522 /* Read the other fields too */
3523 auto simulatedAnnealingPoints = gmx::splitString(inputrecStrings->anneal_npoints);
3524 if (simulatedAnnealingPoints.size() != simulatedAnnealingGroupNames.size())
3526 gmx_fatal(FARGS, "Found %zu annealing-npoints values for %zu groups\n",
3527 simulatedAnnealingPoints.size(), simulatedAnnealingGroupNames.size());
3529 convertInts(wi, simulatedAnnealingPoints, "annealing points", ir->opts.anneal_npoints);
3530 size_t numSimulatedAnnealingFields = 0;
3531 for (i = 0; i < nr; i++)
3533 if (ir->opts.anneal_npoints[i] == 1)
3535 gmx_fatal(
3536 FARGS,
3537 "Please specify at least a start and an end point for annealing\n");
3539 snew(ir->opts.anneal_time[i], ir->opts.anneal_npoints[i]);
3540 snew(ir->opts.anneal_temp[i], ir->opts.anneal_npoints[i]);
3541 numSimulatedAnnealingFields += ir->opts.anneal_npoints[i];
3544 auto simulatedAnnealingTimes = gmx::splitString(inputrecStrings->anneal_time);
3546 if (simulatedAnnealingTimes.size() != numSimulatedAnnealingFields)
3548 gmx_fatal(FARGS, "Found %zu annealing-time values, wanted %zu\n",
3549 simulatedAnnealingTimes.size(), numSimulatedAnnealingFields);
3551 auto simulatedAnnealingTemperatures = gmx::splitString(inputrecStrings->anneal_temp);
3552 if (simulatedAnnealingTemperatures.size() != numSimulatedAnnealingFields)
3554 gmx_fatal(FARGS, "Found %zu annealing-temp values, wanted %zu\n",
3555 simulatedAnnealingTemperatures.size(), numSimulatedAnnealingFields);
3558 std::vector<real> allSimulatedAnnealingTimes(numSimulatedAnnealingFields);
3559 std::vector<real> allSimulatedAnnealingTemperatures(numSimulatedAnnealingFields);
3560 convertReals(wi, simulatedAnnealingTimes, "anneal-time",
3561 allSimulatedAnnealingTimes.data());
3562 convertReals(wi, simulatedAnnealingTemperatures, "anneal-temp",
3563 allSimulatedAnnealingTemperatures.data());
3564 for (i = 0, k = 0; i < nr; i++)
3566 for (j = 0; j < ir->opts.anneal_npoints[i]; j++)
3568 ir->opts.anneal_time[i][j] = allSimulatedAnnealingTimes[k];
3569 ir->opts.anneal_temp[i][j] = allSimulatedAnnealingTemperatures[k];
3570 if (j == 0)
3572 if (ir->opts.anneal_time[i][0] > (ir->init_t + GMX_REAL_EPS))
3574 gmx_fatal(FARGS, "First time point for annealing > init_t.\n");
3577 else
3579 /* j>0 */
3580 if (ir->opts.anneal_time[i][j] < ir->opts.anneal_time[i][j - 1])
3582 gmx_fatal(FARGS,
3583 "Annealing timepoints out of order: t=%f comes after "
3584 "t=%f\n",
3585 ir->opts.anneal_time[i][j], ir->opts.anneal_time[i][j - 1]);
3588 if (ir->opts.anneal_temp[i][j] < 0)
3590 gmx_fatal(FARGS, "Found negative temperature in annealing: %f\n",
3591 ir->opts.anneal_temp[i][j]);
3593 k++;
3596 /* Print out some summary information, to make sure we got it right */
3597 for (i = 0; i < nr; i++)
3599 if (ir->opts.annealing[i] != eannNO)
3601 j = groups->groups[SimulationAtomGroupType::TemperatureCoupling][i];
3602 fprintf(stderr, "Simulated annealing for group %s: %s, %d timepoints\n",
3603 *(groups->groupNames[j]), eann_names[ir->opts.annealing[i]],
3604 ir->opts.anneal_npoints[i]);
3605 fprintf(stderr, "Time (ps) Temperature (K)\n");
3606 /* All terms except the last one */
3607 for (j = 0; j < (ir->opts.anneal_npoints[i] - 1); j++)
3609 fprintf(stderr, "%9.1f %5.1f\n", ir->opts.anneal_time[i][j],
3610 ir->opts.anneal_temp[i][j]);
3613 /* Finally the last one */
3614 j = ir->opts.anneal_npoints[i] - 1;
3615 if (ir->opts.annealing[i] == eannSINGLE)
3617 fprintf(stderr, "%9.1f- %5.1f\n", ir->opts.anneal_time[i][j],
3618 ir->opts.anneal_temp[i][j]);
3620 else
3622 fprintf(stderr, "%9.1f %5.1f\n", ir->opts.anneal_time[i][j],
3623 ir->opts.anneal_temp[i][j]);
3624 if (std::fabs(ir->opts.anneal_temp[i][j] - ir->opts.anneal_temp[i][0]) > GMX_REAL_EPS)
3626 warning_note(wi,
3627 "There is a temperature jump when your annealing "
3628 "loops back.\n");
3637 if (ir->bPull)
3639 make_pull_groups(ir->pull, inputrecStrings->pullGroupNames, defaultIndexGroups, gnames);
3641 make_pull_coords(ir->pull);
3644 if (ir->bRot)
3646 make_rotation_groups(ir->rot, inputrecStrings->rotateGroupNames, defaultIndexGroups, gnames);
3649 if (ir->eSwapCoords != eswapNO)
3651 make_swap_groups(ir->swap, defaultIndexGroups, gnames);
3654 /* Make indices for IMD session */
3655 if (ir->bIMD)
3657 make_IMD_group(ir->imd, inputrecStrings->imd_grp, defaultIndexGroups, gnames);
3660 gmx::IndexGroupsAndNames defaultIndexGroupsAndNames(
3661 *defaultIndexGroups, gmx::arrayRefFromArray(gnames, defaultIndexGroups->nr));
3662 notifier.preProcessingNotifications_.notify(defaultIndexGroupsAndNames);
3664 auto accelerations = gmx::splitString(inputrecStrings->acc);
3665 auto accelerationGroupNames = gmx::splitString(inputrecStrings->accgrps);
3666 if (accelerationGroupNames.size() * DIM != accelerations.size())
3668 gmx_fatal(FARGS, "Invalid Acceleration input: %zu groups and %zu acc. values",
3669 accelerationGroupNames.size(), accelerations.size());
3671 do_numbering(natoms, groups, accelerationGroupNames, defaultIndexGroups, gnames,
3672 SimulationAtomGroupType::Acceleration, restnm, egrptpALL_GENREST, bVerbose, wi);
3673 nr = groups->groups[SimulationAtomGroupType::Acceleration].size();
3674 snew(ir->opts.acc, nr);
3675 ir->opts.ngacc = nr;
3677 convertRvecs(wi, accelerations, "anneal-time", ir->opts.acc);
3679 auto freezeDims = gmx::splitString(inputrecStrings->frdim);
3680 auto freezeGroupNames = gmx::splitString(inputrecStrings->freeze);
3681 if (freezeDims.size() != DIM * freezeGroupNames.size())
3683 gmx_fatal(FARGS, "Invalid Freezing input: %zu groups and %zu freeze values",
3684 freezeGroupNames.size(), freezeDims.size());
3686 do_numbering(natoms, groups, freezeGroupNames, defaultIndexGroups, gnames,
3687 SimulationAtomGroupType::Freeze, restnm, egrptpALL_GENREST, bVerbose, wi);
3688 nr = groups->groups[SimulationAtomGroupType::Freeze].size();
3689 ir->opts.ngfrz = nr;
3690 snew(ir->opts.nFreeze, nr);
3691 for (i = k = 0; (size_t(i) < freezeGroupNames.size()); i++)
3693 for (j = 0; (j < DIM); j++, k++)
3695 ir->opts.nFreeze[i][j] = static_cast<int>(gmx::equalCaseInsensitive(freezeDims[k], "Y", 1));
3696 if (!ir->opts.nFreeze[i][j])
3698 if (!gmx::equalCaseInsensitive(freezeDims[k], "N", 1))
3700 sprintf(warn_buf,
3701 "Please use Y(ES) or N(O) for freezedim only "
3702 "(not %s)",
3703 freezeDims[k].c_str());
3704 warning(wi, warn_buf);
3709 for (; (i < nr); i++)
3711 for (j = 0; (j < DIM); j++)
3713 ir->opts.nFreeze[i][j] = 0;
3717 auto energyGroupNames = gmx::splitString(inputrecStrings->energy);
3718 do_numbering(natoms, groups, energyGroupNames, defaultIndexGroups, gnames,
3719 SimulationAtomGroupType::EnergyOutput, restnm, egrptpALL_GENREST, bVerbose, wi);
3720 add_wall_energrps(groups, ir->nwall, symtab);
3721 ir->opts.ngener = groups->groups[SimulationAtomGroupType::EnergyOutput].size();
3722 auto vcmGroupNames = gmx::splitString(inputrecStrings->vcm);
3723 do_numbering(natoms, groups, vcmGroupNames, defaultIndexGroups, gnames,
3724 SimulationAtomGroupType::MassCenterVelocityRemoval, restnm,
3725 vcmGroupNames.empty() ? egrptpALL_GENREST : egrptpPART, bVerbose, wi);
3727 if (ir->comm_mode != ecmNO)
3729 checkAndUpdateVcmFreezeGroupConsistency(groups, natoms, ir->opts, wi);
3732 /* Now we have filled the freeze struct, so we can calculate NRDF */
3733 calc_nrdf(mtop, ir, gnames);
3735 auto user1GroupNames = gmx::splitString(inputrecStrings->user1);
3736 do_numbering(natoms, groups, user1GroupNames, defaultIndexGroups, gnames,
3737 SimulationAtomGroupType::User1, restnm, egrptpALL_GENREST, bVerbose, wi);
3738 auto user2GroupNames = gmx::splitString(inputrecStrings->user2);
3739 do_numbering(natoms, groups, user2GroupNames, defaultIndexGroups, gnames,
3740 SimulationAtomGroupType::User2, restnm, egrptpALL_GENREST, bVerbose, wi);
3741 auto compressedXGroupNames = gmx::splitString(inputrecStrings->x_compressed_groups);
3742 do_numbering(natoms, groups, compressedXGroupNames, defaultIndexGroups, gnames,
3743 SimulationAtomGroupType::CompressedPositionOutput, restnm, egrptpONE, bVerbose, wi);
3744 auto orirefFitGroupNames = gmx::splitString(inputrecStrings->orirefitgrp);
3745 do_numbering(natoms, groups, orirefFitGroupNames, defaultIndexGroups, gnames,
3746 SimulationAtomGroupType::OrientationRestraintsFit, restnm, egrptpALL_GENREST,
3747 bVerbose, wi);
3749 /* MiMiC QMMM input processing */
3750 auto qmGroupNames = gmx::splitString(inputrecStrings->QMMM);
3751 if (qmGroupNames.size() > 1)
3753 gmx_fatal(FARGS, "Currently, having more than one QM group in MiMiC is not supported");
3755 /* group rest, if any, is always MM! */
3756 do_numbering(natoms, groups, qmGroupNames, defaultIndexGroups, gnames,
3757 SimulationAtomGroupType::QuantumMechanics, restnm, egrptpALL_GENREST, bVerbose, wi);
3758 ir->opts.ngQM = qmGroupNames.size();
3760 /* end of MiMiC QMMM input */
3762 if (bVerbose)
3764 for (auto group : gmx::keysOf(groups->groups))
3766 fprintf(stderr, "%-16s has %zu element(s):", shortName(group), groups->groups[group].size());
3767 for (const auto& entry : groups->groups[group])
3769 fprintf(stderr, " %s", *(groups->groupNames[entry]));
3771 fprintf(stderr, "\n");
3775 nr = groups->groups[SimulationAtomGroupType::EnergyOutput].size();
3776 snew(ir->opts.egp_flags, nr * nr);
3778 bExcl = do_egp_flag(ir, groups, "energygrp-excl", inputrecStrings->egpexcl, EGP_EXCL);
3779 if (bExcl && ir->cutoff_scheme == ecutsVERLET)
3781 warning_error(wi, "Energy group exclusions are currently not supported");
3783 if (bExcl && EEL_FULL(ir->coulombtype))
3785 warning(wi, "Can not exclude the lattice Coulomb energy between energy groups");
3788 bTable = do_egp_flag(ir, groups, "energygrp-table", inputrecStrings->egptable, EGP_TABLE);
3789 if (bTable && !(ir->vdwtype == evdwUSER) && !(ir->coulombtype == eelUSER)
3790 && !(ir->coulombtype == eelPMEUSER) && !(ir->coulombtype == eelPMEUSERSWITCH))
3792 gmx_fatal(FARGS,
3793 "Can only have energy group pair tables in combination with user tables for VdW "
3794 "and/or Coulomb");
3797 /* final check before going out of scope if simulated tempering variables
3798 * need to be set to default values.
3800 if ((ir->expandedvals->nstexpanded < 0) && ir->bSimTemp)
3802 ir->expandedvals->nstexpanded = 2 * static_cast<int>(ir->opts.tau_t[0] / ir->delta_t);
3803 warning(wi, gmx::formatString(
3804 "the value for nstexpanded was not specified for "
3805 " expanded ensemble simulated tempering. It is set to 2*tau_t (%d) "
3806 "by default, but it is recommended to set it to an explicit value!",
3807 ir->expandedvals->nstexpanded));
3809 for (i = 0; (i < defaultIndexGroups->nr); i++)
3811 sfree(gnames[i]);
3813 sfree(gnames);
3814 done_blocka(defaultIndexGroups);
3815 sfree(defaultIndexGroups);
3819 static void check_disre(const gmx_mtop_t* mtop)
3821 if (gmx_mtop_ftype_count(mtop, F_DISRES) > 0)
3823 const gmx_ffparams_t& ffparams = mtop->ffparams;
3824 int ndouble = 0;
3825 int old_label = -1;
3826 for (int i = 0; i < ffparams.numTypes(); i++)
3828 int ftype = ffparams.functype[i];
3829 if (ftype == F_DISRES)
3831 int label = ffparams.iparams[i].disres.label;
3832 if (label == old_label)
3834 fprintf(stderr, "Distance restraint index %d occurs twice\n", label);
3835 ndouble++;
3837 old_label = label;
3840 if (ndouble > 0)
3842 gmx_fatal(FARGS,
3843 "Found %d double distance restraint indices,\n"
3844 "probably the parameters for multiple pairs in one restraint "
3845 "are not identical\n",
3846 ndouble);
3851 static bool absolute_reference(const t_inputrec* ir, const gmx_mtop_t* sys, const bool posres_only, ivec AbsRef)
3853 int d, g, i;
3854 gmx_mtop_ilistloop_t iloop;
3855 int nmol;
3856 const t_iparams* pr;
3858 clear_ivec(AbsRef);
3860 if (!posres_only)
3862 /* Check the COM */
3863 for (d = 0; d < DIM; d++)
3865 AbsRef[d] = (d < ndof_com(ir) ? 0 : 1);
3867 /* Check for freeze groups */
3868 for (g = 0; g < ir->opts.ngfrz; g++)
3870 for (d = 0; d < DIM; d++)
3872 if (ir->opts.nFreeze[g][d] != 0)
3874 AbsRef[d] = 1;
3880 /* Check for position restraints */
3881 iloop = gmx_mtop_ilistloop_init(sys);
3882 while (const InteractionLists* ilist = gmx_mtop_ilistloop_next(iloop, &nmol))
3884 if (nmol > 0 && (AbsRef[XX] == 0 || AbsRef[YY] == 0 || AbsRef[ZZ] == 0))
3886 for (i = 0; i < (*ilist)[F_POSRES].size(); i += 2)
3888 pr = &sys->ffparams.iparams[(*ilist)[F_POSRES].iatoms[i]];
3889 for (d = 0; d < DIM; d++)
3891 if (pr->posres.fcA[d] != 0)
3893 AbsRef[d] = 1;
3897 for (i = 0; i < (*ilist)[F_FBPOSRES].size(); i += 2)
3899 /* Check for flat-bottom posres */
3900 pr = &sys->ffparams.iparams[(*ilist)[F_FBPOSRES].iatoms[i]];
3901 if (pr->fbposres.k != 0)
3903 switch (pr->fbposres.geom)
3905 case efbposresSPHERE: AbsRef[XX] = AbsRef[YY] = AbsRef[ZZ] = 1; break;
3906 case efbposresCYLINDERX: AbsRef[YY] = AbsRef[ZZ] = 1; break;
3907 case efbposresCYLINDERY: AbsRef[XX] = AbsRef[ZZ] = 1; break;
3908 case efbposresCYLINDER:
3909 /* efbposres is a synonym for efbposresCYLINDERZ for backwards compatibility */
3910 case efbposresCYLINDERZ: AbsRef[XX] = AbsRef[YY] = 1; break;
3911 case efbposresX: /* d=XX */
3912 case efbposresY: /* d=YY */
3913 case efbposresZ: /* d=ZZ */
3914 d = pr->fbposres.geom - efbposresX;
3915 AbsRef[d] = 1;
3916 break;
3917 default:
3918 gmx_fatal(FARGS,
3919 " Invalid geometry for flat-bottom position restraint.\n"
3920 "Expected nr between 1 and %d. Found %d\n",
3921 efbposresNR - 1, pr->fbposres.geom);
3928 return (AbsRef[XX] != 0 && AbsRef[YY] != 0 && AbsRef[ZZ] != 0);
3931 static void check_combination_rule_differences(const gmx_mtop_t* mtop,
3932 int state,
3933 bool* bC6ParametersWorkWithGeometricRules,
3934 bool* bC6ParametersWorkWithLBRules,
3935 bool* bLBRulesPossible)
3937 int ntypes, tpi, tpj;
3938 int* typecount;
3939 real tol;
3940 double c6i, c6j, c12i, c12j;
3941 double c6, c6_geometric, c6_LB;
3942 double sigmai, sigmaj, epsi, epsj;
3943 bool bCanDoLBRules, bCanDoGeometricRules;
3944 const char* ptr;
3946 /* A tolerance of 1e-5 seems reasonable for (possibly hand-typed)
3947 * force-field floating point parameters.
3949 tol = 1e-5;
3950 ptr = getenv("GMX_LJCOMB_TOL");
3951 if (ptr != nullptr)
3953 double dbl;
3954 double gmx_unused canary;
3956 if (sscanf(ptr, "%lf%lf", &dbl, &canary) != 1)
3958 gmx_fatal(FARGS,
3959 "Could not parse a single floating-point number from GMX_LJCOMB_TOL (%s)", ptr);
3961 tol = dbl;
3964 *bC6ParametersWorkWithLBRules = TRUE;
3965 *bC6ParametersWorkWithGeometricRules = TRUE;
3966 bCanDoLBRules = TRUE;
3967 ntypes = mtop->ffparams.atnr;
3968 snew(typecount, ntypes);
3969 gmx_mtop_count_atomtypes(mtop, state, typecount);
3970 *bLBRulesPossible = TRUE;
3971 for (tpi = 0; tpi < ntypes; ++tpi)
3973 c6i = mtop->ffparams.iparams[(ntypes + 1) * tpi].lj.c6;
3974 c12i = mtop->ffparams.iparams[(ntypes + 1) * tpi].lj.c12;
3975 for (tpj = tpi; tpj < ntypes; ++tpj)
3977 c6j = mtop->ffparams.iparams[(ntypes + 1) * tpj].lj.c6;
3978 c12j = mtop->ffparams.iparams[(ntypes + 1) * tpj].lj.c12;
3979 c6 = mtop->ffparams.iparams[ntypes * tpi + tpj].lj.c6;
3980 c6_geometric = std::sqrt(c6i * c6j);
3981 if (!gmx_numzero(c6_geometric))
3983 if (!gmx_numzero(c12i) && !gmx_numzero(c12j))
3985 sigmai = gmx::sixthroot(c12i / c6i);
3986 sigmaj = gmx::sixthroot(c12j / c6j);
3987 epsi = c6i * c6i / (4.0 * c12i);
3988 epsj = c6j * c6j / (4.0 * c12j);
3989 c6_LB = 4.0 * std::sqrt(epsi * epsj) * gmx::power6(0.5 * (sigmai + sigmaj));
3991 else
3993 *bLBRulesPossible = FALSE;
3994 c6_LB = c6_geometric;
3996 bCanDoLBRules = gmx_within_tol(c6_LB, c6, tol);
3999 if (!bCanDoLBRules)
4001 *bC6ParametersWorkWithLBRules = FALSE;
4004 bCanDoGeometricRules = gmx_within_tol(c6_geometric, c6, tol);
4006 if (!bCanDoGeometricRules)
4008 *bC6ParametersWorkWithGeometricRules = FALSE;
4012 sfree(typecount);
4015 static void check_combination_rules(const t_inputrec* ir, const gmx_mtop_t* mtop, warninp_t wi)
4017 bool bLBRulesPossible, bC6ParametersWorkWithGeometricRules, bC6ParametersWorkWithLBRules;
4019 check_combination_rule_differences(mtop, 0, &bC6ParametersWorkWithGeometricRules,
4020 &bC6ParametersWorkWithLBRules, &bLBRulesPossible);
4021 if (ir->ljpme_combination_rule == eljpmeLB)
4023 if (!bC6ParametersWorkWithLBRules || !bLBRulesPossible)
4025 warning(wi,
4026 "You are using arithmetic-geometric combination rules "
4027 "in LJ-PME, but your non-bonded C6 parameters do not "
4028 "follow these rules.");
4031 else
4033 if (!bC6ParametersWorkWithGeometricRules)
4035 if (ir->eDispCorr != edispcNO)
4037 warning_note(wi,
4038 "You are using geometric combination rules in "
4039 "LJ-PME, but your non-bonded C6 parameters do "
4040 "not follow these rules. "
4041 "This will introduce very small errors in the forces and energies in "
4042 "your simulations. Dispersion correction will correct total energy "
4043 "and/or pressure for isotropic systems, but not forces or surface "
4044 "tensions.");
4046 else
4048 warning_note(wi,
4049 "You are using geometric combination rules in "
4050 "LJ-PME, but your non-bonded C6 parameters do "
4051 "not follow these rules. "
4052 "This will introduce very small errors in the forces and energies in "
4053 "your simulations. If your system is homogeneous, consider using "
4054 "dispersion correction "
4055 "for the total energy and pressure.");
4061 void triple_check(const char* mdparin, t_inputrec* ir, gmx_mtop_t* sys, warninp_t wi)
4063 char err_buf[STRLEN];
4064 int i, m, c, nmol;
4065 bool bCharge, bAcc;
4066 real * mgrp, mt;
4067 rvec acc;
4068 gmx_mtop_atomloop_block_t aloopb;
4069 ivec AbsRef;
4070 char warn_buf[STRLEN];
4072 set_warning_line(wi, mdparin, -1);
4074 if (absolute_reference(ir, sys, false, AbsRef))
4076 warning_note(wi,
4077 "Removing center of mass motion in the presence of position restraints might "
4078 "cause artifacts. When you are using position restraints to equilibrate a "
4079 "macro-molecule, the artifacts are usually negligible.");
4082 if (ir->cutoff_scheme == ecutsVERLET && ir->verletbuf_tol > 0 && ir->nstlist > 1
4083 && ((EI_MD(ir->eI) || EI_SD(ir->eI)) && (ir->etc == etcVRESCALE || ir->etc == etcBERENDSEN)))
4085 /* Check if a too small Verlet buffer might potentially
4086 * cause more drift than the thermostat can couple off.
4088 /* Temperature error fraction for warning and suggestion */
4089 const real T_error_warn = 0.002;
4090 const real T_error_suggest = 0.001;
4091 /* For safety: 2 DOF per atom (typical with constraints) */
4092 const real nrdf_at = 2;
4093 real T, tau, max_T_error;
4094 int i;
4096 T = 0;
4097 tau = 0;
4098 for (i = 0; i < ir->opts.ngtc; i++)
4100 T = std::max(T, ir->opts.ref_t[i]);
4101 tau = std::max(tau, ir->opts.tau_t[i]);
4103 if (T > 0)
4105 /* This is a worst case estimate of the temperature error,
4106 * assuming perfect buffer estimation and no cancelation
4107 * of errors. The factor 0.5 is because energy distributes
4108 * equally over Ekin and Epot.
4110 max_T_error = 0.5 * tau * ir->verletbuf_tol / (nrdf_at * BOLTZ * T);
4111 if (max_T_error > T_error_warn)
4113 sprintf(warn_buf,
4114 "With a verlet-buffer-tolerance of %g kJ/mol/ps, a reference temperature "
4115 "of %g and a tau_t of %g, your temperature might be off by up to %.1f%%. "
4116 "To ensure the error is below %.1f%%, decrease verlet-buffer-tolerance to "
4117 "%.0e or decrease tau_t.",
4118 ir->verletbuf_tol, T, tau, 100 * max_T_error, 100 * T_error_suggest,
4119 ir->verletbuf_tol * T_error_suggest / max_T_error);
4120 warning(wi, warn_buf);
4125 if (ETC_ANDERSEN(ir->etc))
4127 int i;
4129 for (i = 0; i < ir->opts.ngtc; i++)
4131 sprintf(err_buf,
4132 "all tau_t must currently be equal using Andersen temperature control, "
4133 "violated for group %d",
4135 CHECK(ir->opts.tau_t[0] != ir->opts.tau_t[i]);
4136 sprintf(err_buf,
4137 "all tau_t must be positive using Andersen temperature control, "
4138 "tau_t[%d]=%10.6f",
4139 i, ir->opts.tau_t[i]);
4140 CHECK(ir->opts.tau_t[i] < 0);
4143 if (ir->etc == etcANDERSENMASSIVE && ir->comm_mode != ecmNO)
4145 for (i = 0; i < ir->opts.ngtc; i++)
4147 int nsteps = gmx::roundToInt(ir->opts.tau_t[i] / ir->delta_t);
4148 sprintf(err_buf,
4149 "tau_t/delta_t for group %d for temperature control method %s must be a "
4150 "multiple of nstcomm (%d), as velocities of atoms in coupled groups are "
4151 "randomized every time step. The input tau_t (%8.3f) leads to %d steps per "
4152 "randomization",
4153 i, etcoupl_names[ir->etc], ir->nstcomm, ir->opts.tau_t[i], nsteps);
4154 CHECK(nsteps % ir->nstcomm != 0);
4159 if (EI_DYNAMICS(ir->eI) && !EI_SD(ir->eI) && ir->eI != eiBD && ir->comm_mode == ecmNO
4160 && !(absolute_reference(ir, sys, FALSE, AbsRef) || ir->nsteps <= 10) && !ETC_ANDERSEN(ir->etc))
4162 warning(wi,
4163 "You are not using center of mass motion removal (mdp option comm-mode), numerical "
4164 "rounding errors can lead to build up of kinetic energy of the center of mass");
4167 if (ir->epc == epcPARRINELLORAHMAN && ir->etc == etcNOSEHOOVER)
4169 real tau_t_max = 0;
4170 for (int g = 0; g < ir->opts.ngtc; g++)
4172 tau_t_max = std::max(tau_t_max, ir->opts.tau_t[g]);
4174 if (ir->tau_p < 1.9 * tau_t_max)
4176 std::string message = gmx::formatString(
4177 "With %s T-coupling and %s p-coupling, "
4178 "%s (%g) should be at least twice as large as %s (%g) to avoid resonances",
4179 etcoupl_names[ir->etc], epcoupl_names[ir->epc], "tau-p", ir->tau_p, "tau-t",
4180 tau_t_max);
4181 warning(wi, message.c_str());
4185 /* Check for pressure coupling with absolute position restraints */
4186 if (ir->epc != epcNO && ir->refcoord_scaling == erscNO)
4188 absolute_reference(ir, sys, TRUE, AbsRef);
4190 for (m = 0; m < DIM; m++)
4192 if (AbsRef[m] && norm2(ir->compress[m]) > 0)
4194 warning(wi,
4195 "You are using pressure coupling with absolute position restraints, "
4196 "this will give artifacts. Use the refcoord_scaling option.");
4197 break;
4203 bCharge = FALSE;
4204 aloopb = gmx_mtop_atomloop_block_init(sys);
4205 const t_atom* atom;
4206 while (gmx_mtop_atomloop_block_next(aloopb, &atom, &nmol))
4208 if (atom->q != 0 || atom->qB != 0)
4210 bCharge = TRUE;
4214 if (!bCharge)
4216 if (EEL_FULL(ir->coulombtype))
4218 sprintf(err_buf,
4219 "You are using full electrostatics treatment %s for a system without charges.\n"
4220 "This costs a lot of performance for just processing zeros, consider using %s "
4221 "instead.\n",
4222 EELTYPE(ir->coulombtype), EELTYPE(eelCUT));
4223 warning(wi, err_buf);
4226 else
4228 if (ir->coulombtype == eelCUT && ir->rcoulomb > 0)
4230 sprintf(err_buf,
4231 "You are using a plain Coulomb cut-off, which might produce artifacts.\n"
4232 "You might want to consider using %s electrostatics.\n",
4233 EELTYPE(eelPME));
4234 warning_note(wi, err_buf);
4238 /* Check if combination rules used in LJ-PME are the same as in the force field */
4239 if (EVDW_PME(ir->vdwtype))
4241 check_combination_rules(ir, sys, wi);
4244 /* Generalized reaction field */
4245 if (ir->coulombtype == eelGRF_NOTUSED)
4247 warning_error(wi,
4248 "Generalized reaction-field electrostatics is no longer supported. "
4249 "You can use normal reaction-field instead and compute the reaction-field "
4250 "constant by hand.");
4253 bAcc = FALSE;
4254 for (int i = 0; (i < gmx::ssize(sys->groups.groups[SimulationAtomGroupType::Acceleration])); i++)
4256 for (m = 0; (m < DIM); m++)
4258 if (fabs(ir->opts.acc[i][m]) > 1e-6)
4260 bAcc = TRUE;
4264 if (bAcc)
4266 clear_rvec(acc);
4267 snew(mgrp, sys->groups.groups[SimulationAtomGroupType::Acceleration].size());
4268 for (const AtomProxy atomP : AtomRange(*sys))
4270 const t_atom& local = atomP.atom();
4271 int i = atomP.globalAtomNumber();
4272 mgrp[getGroupType(sys->groups, SimulationAtomGroupType::Acceleration, i)] += local.m;
4274 mt = 0.0;
4275 for (i = 0; (i < gmx::ssize(sys->groups.groups[SimulationAtomGroupType::Acceleration])); i++)
4277 for (m = 0; (m < DIM); m++)
4279 acc[m] += ir->opts.acc[i][m] * mgrp[i];
4281 mt += mgrp[i];
4283 for (m = 0; (m < DIM); m++)
4285 if (fabs(acc[m]) > 1e-6)
4287 const char* dim[DIM] = { "X", "Y", "Z" };
4288 fprintf(stderr, "Net Acceleration in %s direction, will %s be corrected\n", dim[m],
4289 ir->nstcomm != 0 ? "" : "not");
4290 if (ir->nstcomm != 0 && m < ndof_com(ir))
4292 acc[m] /= mt;
4293 for (i = 0;
4294 (i < gmx::ssize(sys->groups.groups[SimulationAtomGroupType::Acceleration])); i++)
4296 ir->opts.acc[i][m] -= acc[m];
4301 sfree(mgrp);
4304 if (ir->efep != efepNO && ir->fepvals->sc_alpha != 0
4305 && !gmx_within_tol(sys->ffparams.reppow, 12.0, 10 * GMX_DOUBLE_EPS))
4307 gmx_fatal(FARGS, "Soft-core interactions are only supported with VdW repulsion power 12");
4310 if (ir->bPull)
4312 bool bWarned;
4314 bWarned = FALSE;
4315 for (i = 0; i < ir->pull->ncoord && !bWarned; i++)
4317 if (ir->pull->coord[i].group[0] == 0 || ir->pull->coord[i].group[1] == 0)
4319 absolute_reference(ir, sys, FALSE, AbsRef);
4320 for (m = 0; m < DIM; m++)
4322 if (ir->pull->coord[i].dim[m] && !AbsRef[m])
4324 warning(wi,
4325 "You are using an absolute reference for pulling, but the rest of "
4326 "the system does not have an absolute reference. This will lead to "
4327 "artifacts.");
4328 bWarned = TRUE;
4329 break;
4335 for (i = 0; i < 3; i++)
4337 for (m = 0; m <= i; m++)
4339 if ((ir->epc != epcNO && ir->compress[i][m] != 0) || ir->deform[i][m] != 0)
4341 for (c = 0; c < ir->pull->ncoord; c++)
4343 if (ir->pull->coord[c].eGeom == epullgDIRPBC && ir->pull->coord[c].vec[m] != 0)
4345 gmx_fatal(FARGS,
4346 "Can not have dynamic box while using pull geometry '%s' "
4347 "(dim %c)",
4348 EPULLGEOM(ir->pull->coord[c].eGeom), 'x' + m);
4356 check_disre(sys);
4359 void double_check(t_inputrec* ir, matrix box, bool bHasNormalConstraints, bool bHasAnyConstraints, warninp_t wi)
4361 char warn_buf[STRLEN];
4362 const char* ptr;
4364 ptr = check_box(ir->pbcType, box);
4365 if (ptr)
4367 warning_error(wi, ptr);
4370 if (bHasNormalConstraints && ir->eConstrAlg == econtSHAKE)
4372 if (ir->shake_tol <= 0.0)
4374 sprintf(warn_buf, "ERROR: shake-tol must be > 0 instead of %g\n", ir->shake_tol);
4375 warning_error(wi, warn_buf);
4379 if ((ir->eConstrAlg == econtLINCS) && bHasNormalConstraints)
4381 /* If we have Lincs constraints: */
4382 if (ir->eI == eiMD && ir->etc == etcNO && ir->eConstrAlg == econtLINCS && ir->nLincsIter == 1)
4384 sprintf(warn_buf,
4385 "For energy conservation with LINCS, lincs_iter should be 2 or larger.\n");
4386 warning_note(wi, warn_buf);
4389 if ((ir->eI == eiCG || ir->eI == eiLBFGS) && (ir->nProjOrder < 8))
4391 sprintf(warn_buf,
4392 "For accurate %s with LINCS constraints, lincs-order should be 8 or more.",
4393 ei_names[ir->eI]);
4394 warning_note(wi, warn_buf);
4396 if (ir->epc == epcMTTK)
4398 warning_error(wi, "MTTK not compatible with lincs -- use shake instead.");
4402 if (bHasAnyConstraints && ir->epc == epcMTTK)
4404 warning_error(wi, "Constraints are not implemented with MTTK pressure control.");
4407 if (ir->LincsWarnAngle > 90.0)
4409 sprintf(warn_buf, "lincs-warnangle can not be larger than 90 degrees, setting it to 90.\n");
4410 warning(wi, warn_buf);
4411 ir->LincsWarnAngle = 90.0;
4414 if (ir->pbcType != PbcType::No)
4416 if (ir->nstlist == 0)
4418 warning(wi,
4419 "With nstlist=0 atoms are only put into the box at step 0, therefore drifting "
4420 "atoms might cause the simulation to crash.");
4422 if (gmx::square(ir->rlist) >= max_cutoff2(ir->pbcType, box))
4424 sprintf(warn_buf,
4425 "ERROR: The cut-off length is longer than half the shortest box vector or "
4426 "longer than the smallest box diagonal element. Increase the box size or "
4427 "decrease rlist.\n");
4428 warning_error(wi, warn_buf);