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,2018,2019, by the GROMACS development team, led by
7 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
8 * and including many others, as listed in the AUTHORS file in the
9 * top-level source directory and at http://www.gromacs.org.
11 * GROMACS is free software; you can redistribute it and/or
12 * modify it under the terms of the GNU Lesser General Public License
13 * as published by the Free Software Foundation; either version 2.1
14 * of the License, or (at your option) any later version.
16 * GROMACS is distributed in the hope that it will be useful,
17 * but WITHOUT ANY WARRANTY; without even the implied warranty of
18 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
19 * Lesser General Public License for more details.
21 * You should have received a copy of the GNU Lesser General Public
22 * License along with GROMACS; if not, see
23 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
24 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
26 * If you want to redistribute modifications to GROMACS, please
27 * consider that scientific software is very special. Version
28 * control is crucial - bugs must be traceable. We will be happy to
29 * consider code for inclusion in the official distribution, but
30 * derived work must not be called official GROMACS. Details are found
31 * in the README & COPYING files - if they are missing, get the
32 * official version at http://www.gromacs.org.
34 * To help us fund GROMACS development, we humbly ask that you cite
35 * the research papers on the package. Check out http://www.gromacs.org.
49 #include "gromacs/fileio/warninp.h"
50 #include "gromacs/gmxpreprocess/gpp_atomtype.h"
51 #include "gromacs/gmxpreprocess/gpp_bond_atomtype.h"
52 #include "gromacs/gmxpreprocess/grompp-impl.h"
53 #include "gromacs/gmxpreprocess/notset.h"
54 #include "gromacs/gmxpreprocess/readir.h"
55 #include "gromacs/gmxpreprocess/topdirs.h"
56 #include "gromacs/gmxpreprocess/toputil.h"
57 #include "gromacs/math/functions.h"
58 #include "gromacs/mdtypes/md_enums.h"
59 #include "gromacs/topology/exclusionblocks.h"
60 #include "gromacs/topology/ifunc.h"
61 #include "gromacs/topology/symtab.h"
62 #include "gromacs/utility/arrayref.h"
63 #include "gromacs/utility/cstringutil.h"
64 #include "gromacs/utility/fatalerror.h"
65 #include "gromacs/utility/gmxassert.h"
66 #include "gromacs/utility/smalloc.h"
67 #include "gromacs/utility/stringutil.h"
69 void generate_nbparams(int comb
, int ftype
, t_params
*plist
, gpp_atomtype
*atype
,
74 real c
, bi
, bj
, ci
, cj
, ci0
, ci1
, ci2
, cj0
, cj1
, cj2
;
76 /* Lean mean shortcuts */
77 nr
= get_atomtype_ntypes(atype
);
79 snew(plist
->param
, nr
*nr
);
82 /* Fill the matrix with force parameters */
90 for (i
= k
= 0; (i
< nr
); i
++)
92 for (j
= 0; (j
< nr
); j
++, k
++)
94 for (nf
= 0; (nf
< nrfp
); nf
++)
96 ci
= get_atomtype_nbparam(i
, nf
, atype
);
97 cj
= get_atomtype_nbparam(j
, nf
, atype
);
98 c
= std::sqrt(ci
* cj
);
99 plist
->param
[k
].c
[nf
] = c
;
105 case eCOMB_ARITHMETIC
:
106 /* c0 and c1 are sigma and epsilon */
107 for (i
= k
= 0; (i
< nr
); i
++)
109 for (j
= 0; (j
< nr
); j
++, k
++)
111 ci0
= get_atomtype_nbparam(i
, 0, atype
);
112 cj0
= get_atomtype_nbparam(j
, 0, atype
);
113 ci1
= get_atomtype_nbparam(i
, 1, atype
);
114 cj1
= get_atomtype_nbparam(j
, 1, atype
);
115 plist
->param
[k
].c
[0] = (fabs(ci0
) + fabs(cj0
))*0.5;
116 /* Negative sigma signals that c6 should be set to zero later,
117 * so we need to propagate that through the combination rules.
119 if (ci0
< 0 || cj0
< 0)
121 plist
->param
[k
].c
[0] *= -1;
123 plist
->param
[k
].c
[1] = std::sqrt(ci1
*cj1
);
128 case eCOMB_GEOM_SIG_EPS
:
129 /* c0 and c1 are sigma and epsilon */
130 for (i
= k
= 0; (i
< nr
); i
++)
132 for (j
= 0; (j
< nr
); j
++, k
++)
134 ci0
= get_atomtype_nbparam(i
, 0, atype
);
135 cj0
= get_atomtype_nbparam(j
, 0, atype
);
136 ci1
= get_atomtype_nbparam(i
, 1, atype
);
137 cj1
= get_atomtype_nbparam(j
, 1, atype
);
138 plist
->param
[k
].c
[0] = std::sqrt(std::fabs(ci0
*cj0
));
139 /* Negative sigma signals that c6 should be set to zero later,
140 * so we need to propagate that through the combination rules.
142 if (ci0
< 0 || cj0
< 0)
144 plist
->param
[k
].c
[0] *= -1;
146 plist
->param
[k
].c
[1] = std::sqrt(ci1
*cj1
);
152 auto message
= gmx::formatString("No such combination rule %d", comb
);
153 warning_error_and_exit(wi
, message
, FARGS
);
157 gmx_incons("Topology processing, generate nb parameters");
162 /* Buckingham rules */
163 for (i
= k
= 0; (i
< nr
); i
++)
165 for (j
= 0; (j
< nr
); j
++, k
++)
167 ci0
= get_atomtype_nbparam(i
, 0, atype
);
168 cj0
= get_atomtype_nbparam(j
, 0, atype
);
169 ci2
= get_atomtype_nbparam(i
, 2, atype
);
170 cj2
= get_atomtype_nbparam(j
, 2, atype
);
171 bi
= get_atomtype_nbparam(i
, 1, atype
);
172 bj
= get_atomtype_nbparam(j
, 1, atype
);
173 plist
->param
[k
].c
[0] = std::sqrt(ci0
* cj0
);
174 if ((bi
== 0) || (bj
== 0))
176 plist
->param
[k
].c
[1] = 0;
180 plist
->param
[k
].c
[1] = 2.0/(1/bi
+1/bj
);
182 plist
->param
[k
].c
[2] = std::sqrt(ci2
* cj2
);
188 auto message
= gmx::formatString("Invalid nonbonded type %s",
189 interaction_function
[ftype
].longname
);
190 warning_error(wi
, message
);
194 /*! \brief Used to temporarily store the explicit non-bonded parameter
195 * combinations, which will be copied to t_params. */
198 //! Has this combination been set.
200 //! The non-bonded parameters
204 static void realloc_nb_params(gpp_atomtype
*at
,
205 t_nbparam
***nbparam
, t_nbparam
***pair
)
207 /* Add space in the non-bonded parameters matrix */
208 int atnr
= get_atomtype_ntypes(at
);
209 srenew(*nbparam
, atnr
);
210 snew((*nbparam
)[atnr
-1], atnr
);
214 snew((*pair
)[atnr
-1], atnr
);
218 int copy_nbparams(t_nbparam
**param
, int ftype
, t_params
*plist
, int nr
)
226 for (i
= 0; i
< nr
; i
++)
228 for (j
= 0; j
<= i
; j
++)
230 GMX_RELEASE_ASSERT(param
, "Must have valid parameters");
231 if (param
[i
][j
].bSet
)
233 for (f
= 0; f
< nrfp
; f
++)
235 plist
->param
[nr
*i
+j
].c
[f
] = param
[i
][j
].c
[f
];
236 plist
->param
[nr
*j
+i
].c
[f
] = param
[i
][j
].c
[f
];
246 void free_nbparam(t_nbparam
**param
, int nr
)
250 GMX_RELEASE_ASSERT(param
, "Must have valid parameters");
251 for (i
= 0; i
< nr
; i
++)
253 GMX_RELEASE_ASSERT(param
[i
], "Must have valid parameters");
259 static void copy_B_from_A(int ftype
, double *c
)
263 nrfpA
= NRFPA(ftype
);
264 nrfpB
= NRFPB(ftype
);
266 /* Copy the B parameters from the first nrfpB A parameters */
267 for (i
= 0; (i
< nrfpB
); i
++)
273 void push_at (t_symtab
*symtab
, gpp_atomtype
*at
, gpp_bond_atomtype
*bat
,
274 char *line
, int nb_funct
,
275 t_nbparam
***nbparam
, t_nbparam
***pair
,
282 t_xlate xl
[eptNR
] = {
290 int nr
, i
, nfields
, j
, pt
, nfp0
= -1;
291 int batype_nr
, nread
;
292 char type
[STRLEN
], btype
[STRLEN
], ptype
[STRLEN
];
294 double c
[MAXFORCEPARAM
];
295 char tmpfield
[12][100]; /* Max 12 fields of width 100 */
299 bool have_atomic_number
;
300 bool have_bonded_type
;
305 /* First assign input line to temporary array */
306 nfields
= sscanf(line
, "%s%s%s%s%s%s%s%s%s%s%s%s",
307 tmpfield
[0], tmpfield
[1], tmpfield
[2], tmpfield
[3], tmpfield
[4], tmpfield
[5],
308 tmpfield
[6], tmpfield
[7], tmpfield
[8], tmpfield
[9], tmpfield
[10], tmpfield
[11]);
310 /* Comments on optional fields in the atomtypes section:
312 * The force field format is getting a bit old. For OPLS-AA we needed
313 * to add a special bonded atomtype, and for Gerrit Groenhofs QM/MM stuff
314 * we also needed the atomic numbers.
315 * To avoid making all old or user-generated force fields unusable we
316 * have introduced both these quantities as optional columns, and do some
317 * acrobatics to check whether they are present or not.
318 * This will all look much nicer when we switch to XML... sigh.
320 * Field 0 (mandatory) is the nonbonded type name. (string)
321 * Field 1 (optional) is the bonded type (string)
322 * Field 2 (optional) is the atomic number (int)
323 * Field 3 (mandatory) is the mass (numerical)
324 * Field 4 (mandatory) is the charge (numerical)
325 * Field 5 (mandatory) is the particle type (single character)
326 * This is followed by a number of nonbonded parameters.
328 * The safest way to identify the format is the particle type field.
330 * So, here is what we do:
332 * A. Read in the first six fields as strings
333 * B. If field 3 (starting from 0) is a single char, we have neither
334 * bonded_type or atomic numbers.
335 * C. If field 5 is a single char we have both.
336 * D. If field 4 is a single char we check field 1. If this begins with
337 * an alphabetical character we have bonded types, otherwise atomic numbers.
346 if ( (strlen(tmpfield
[5]) == 1) && isalpha(tmpfield
[5][0]) )
348 have_bonded_type
= TRUE
;
349 have_atomic_number
= TRUE
;
351 else if ( (strlen(tmpfield
[3]) == 1) && isalpha(tmpfield
[3][0]) )
353 have_bonded_type
= FALSE
;
354 have_atomic_number
= FALSE
;
358 have_bonded_type
= ( isalpha(tmpfield
[1][0]) != 0 );
359 have_atomic_number
= !have_bonded_type
;
362 /* optional fields */
371 if (have_atomic_number
)
373 if (have_bonded_type
)
375 nread
= sscanf(line
, "%s%s%d%lf%lf%s%lf%lf",
376 type
, btype
, &atomnr
, &m
, &q
, ptype
, &c
[0], &c
[1]);
385 /* have_atomic_number && !have_bonded_type */
386 nread
= sscanf(line
, "%s%d%lf%lf%s%lf%lf",
387 type
, &atomnr
, &m
, &q
, ptype
, &c
[0], &c
[1]);
397 if (have_bonded_type
)
399 /* !have_atomic_number && have_bonded_type */
400 nread
= sscanf(line
, "%s%s%lf%lf%s%lf%lf",
401 type
, btype
, &m
, &q
, ptype
, &c
[0], &c
[1]);
410 /* !have_atomic_number && !have_bonded_type */
411 nread
= sscanf(line
, "%s%lf%lf%s%lf%lf",
412 type
, &m
, &q
, ptype
, &c
[0], &c
[1]);
421 if (!have_bonded_type
)
426 if (!have_atomic_number
)
436 if (have_atomic_number
)
438 if (have_bonded_type
)
440 nread
= sscanf(line
, "%s%s%d%lf%lf%s%lf%lf%lf",
441 type
, btype
, &atomnr
, &m
, &q
, ptype
, &c
[0], &c
[1], &c
[2]);
450 /* have_atomic_number && !have_bonded_type */
451 nread
= sscanf(line
, "%s%d%lf%lf%s%lf%lf%lf",
452 type
, &atomnr
, &m
, &q
, ptype
, &c
[0], &c
[1], &c
[2]);
462 if (have_bonded_type
)
464 /* !have_atomic_number && have_bonded_type */
465 nread
= sscanf(line
, "%s%s%lf%lf%s%lf%lf%lf",
466 type
, btype
, &m
, &q
, ptype
, &c
[0], &c
[1], &c
[2]);
475 /* !have_atomic_number && !have_bonded_type */
476 nread
= sscanf(line
, "%s%lf%lf%s%lf%lf%lf",
477 type
, &m
, &q
, ptype
, &c
[0], &c
[1], &c
[2]);
486 if (!have_bonded_type
)
491 if (!have_atomic_number
)
499 auto message
= gmx::formatString("Invalid function type %d in push_at", nb_funct
);
500 warning_error_and_exit(wi
, message
, FARGS
);
502 for (j
= nfp0
; (j
< MAXFORCEPARAM
); j
++)
507 if (strlen(type
) == 1 && isdigit(type
[0]))
509 warning_error_and_exit(wi
, "Atom type names can't be single digits.", FARGS
);
512 if (strlen(btype
) == 1 && isdigit(btype
[0]))
514 warning_error_and_exit(wi
, "Bond atom type names can't be single digits.", FARGS
);
517 /* Hack to read old topologies */
518 if (gmx_strcasecmp(ptype
, "D") == 0)
522 for (j
= 0; (j
< eptNR
); j
++)
524 if (gmx_strcasecmp(ptype
, xl
[j
].entry
) == 0)
531 auto message
= gmx::formatString("Invalid particle type %s", ptype
);
532 warning_error_and_exit(wi
, message
, FARGS
);
539 for (i
= 0; (i
< MAXFORCEPARAM
); i
++)
544 if ((batype_nr
= get_bond_atomtype_type(btype
, bat
)) == NOTSET
)
546 add_bond_atomtype(bat
, symtab
, btype
);
548 batype_nr
= get_bond_atomtype_type(btype
, bat
);
550 if ((nr
= get_atomtype_type(type
, at
)) != NOTSET
)
552 auto message
= gmx::formatString("Overriding atomtype %s", type
);
553 warning(wi
, message
);
554 if ((nr
= set_atomtype(nr
, at
, symtab
, atom
, type
, param
, batype_nr
,
557 auto message
= gmx::formatString("Replacing atomtype %s failed", type
);
558 warning_error_and_exit(wi
, message
, FARGS
);
561 else if ((add_atomtype(at
, symtab
, atom
, type
, param
,
562 batype_nr
, atomnr
)) == NOTSET
)
564 auto message
= gmx::formatString("Adding atomtype %s failed", type
);
565 warning_error_and_exit(wi
, message
, FARGS
);
569 /* Add space in the non-bonded parameters matrix */
570 realloc_nb_params(at
, nbparam
, pair
);
576 //! Return whether the contents of \c a and \c b are the same, considering also reversed order.
577 template <typename T
>
578 static bool equalEitherForwardOrBackward(gmx::ArrayRef
<const T
> a
, gmx::ArrayRef
<const T
> b
)
580 return (std::equal(a
.begin(), a
.end(), b
.begin()) ||
581 std::equal(a
.begin(), a
.end(), b
.rbegin()));
584 static void push_bondtype(t_params
* bt
,
593 int nrfp
= NRFP(ftype
);
595 /* If bAllowRepeat is TRUE, we allow multiple entries as long as they
596 are on directly _adjacent_ lines.
599 /* First check if our atomtypes are _identical_ (not reversed) to the previous
600 entry. If they are not identical we search for earlier duplicates. If they are
601 we can skip it, since we already searched for the first line
605 bool isContinuationOfBlock
= false;
606 if (bAllowRepeat
&& nr
> 1)
608 isContinuationOfBlock
= true;
609 for (int j
= 0; j
< nral
; j
++)
611 if (b
->a
[j
] != bt
->param
[nr
- 2].a
[j
])
613 isContinuationOfBlock
= false;
618 /* Search for earlier duplicates if this entry was not a continuation
619 from the previous line.
621 bool addBondType
= true;
622 bool haveWarned
= false;
623 bool haveErrored
= false;
624 for (int i
= 0; (i
< nr
); i
++)
626 gmx::ArrayRef
<const int> bParams(b
->a
, b
->a
+ nral
);
627 gmx::ArrayRef
<const int> testParams(bt
->param
[i
].a
, bt
->param
[i
].a
+ nral
);
628 if (equalEitherForwardOrBackward(bParams
, testParams
))
630 GMX_ASSERT(nrfp
<= MAXFORCEPARAM
, "This is ensured in other places, but we need this assert to keep the clang analyzer happy");
631 const bool identicalParameters
= std::equal(bt
->param
[i
].c
, bt
->param
[i
].c
+ nrfp
, b
->c
);
633 if (!bAllowRepeat
|| identicalParameters
)
638 if (!identicalParameters
)
642 /* With dihedral type 9 we only allow for repeating
643 * of the same parameters with blocks with 1 entry.
644 * Allowing overriding is too complex to check.
646 if (!isContinuationOfBlock
&& !haveErrored
)
648 warning_error(wi
, "Encountered a second block of parameters for dihedral "
649 "type 9 for the same atoms, with either different parameters "
650 "and/or the first block has multiple lines. This is not supported.");
654 else if (!haveWarned
)
656 auto message
= gmx::formatString
657 ("Overriding %s parameters.%s",
658 interaction_function
[ftype
].longname
,
660 "\nUse dihedraltype 9 to allow several multiplicity terms. Only consecutive "
661 "lines are combined. Non-consective lines overwrite each other."
663 warning(wi
, message
);
665 fprintf(stderr
, " old: ");
666 for (int j
= 0; (j
< nrfp
); j
++)
668 fprintf(stderr
, " %g", bt
->param
[i
].c
[j
]);
670 fprintf(stderr
, " \n new: %s\n\n", line
);
676 if (!identicalParameters
&& !bAllowRepeat
)
678 /* Overwrite the parameters with the latest ones */
679 // TODO considering improving the following code by replacing with:
680 // std::copy(b->c, b->c + nrfp, bt->param[i].c);
681 for (int j
= 0; (j
< nrfp
); j
++)
683 bt
->param
[i
].c
[j
] = b
->c
[j
];
694 /* fill the arrays up and down */
695 memcpy(bt
->param
[bt
->nr
].c
, b
->c
, sizeof(b
->c
));
696 memcpy(bt
->param
[bt
->nr
].a
, b
->a
, sizeof(b
->a
));
697 memcpy(bt
->param
[bt
->nr
+1].c
, b
->c
, sizeof(b
->c
));
699 /* The definitions of linear angles depend on the order of atoms,
700 * that means that for atoms i-j-k, with certain parameter a, the
701 * corresponding k-j-i angle will have parameter 1-a.
703 if (ftype
== F_LINEAR_ANGLES
)
705 bt
->param
[bt
->nr
+1].c
[0] = 1-bt
->param
[bt
->nr
+1].c
[0];
706 bt
->param
[bt
->nr
+1].c
[2] = 1-bt
->param
[bt
->nr
+1].c
[2];
709 for (int j
= 0; (j
< nral
); j
++)
711 bt
->param
[bt
->nr
+1].a
[j
] = b
->a
[nral
-1-j
];
718 void push_bt(Directive d
, t_params bt
[], int nral
,
720 gpp_bond_atomtype
*bat
, char *line
,
723 const char *formal
[MAXATOMLIST
+1] = {
732 const char *formnl
[MAXATOMLIST
+1] = {
738 "%*s%*s%*s%*s%*s%*s",
739 "%*s%*s%*s%*s%*s%*s%*s"
741 const char *formlf
= "%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf";
742 int i
, ft
, ftype
, nn
, nrfp
, nrfpA
;
744 char alc
[MAXATOMLIST
+1][20];
745 /* One force parameter more, so we can check if we read too many */
746 double c
[MAXFORCEPARAM
+1];
749 if ((bat
&& at
) || (!bat
&& !at
))
751 gmx_incons("You should pass either bat or at to push_bt");
754 /* Make format string (nral ints+functype) */
755 if ((nn
= sscanf(line
, formal
[nral
],
756 alc
[0], alc
[1], alc
[2], alc
[3], alc
[4], alc
[5])) != nral
+1)
758 auto message
= gmx::formatString("Not enough atomtypes (%d instead of %d)", nn
-1, nral
);
759 warning_error(wi
, message
);
763 ft
= strtol(alc
[nral
], nullptr, 10);
764 ftype
= ifunc_index(d
, ft
);
766 nrfpA
= interaction_function
[ftype
].nrfpA
;
767 strcpy(f1
, formnl
[nral
]);
769 if ((nn
= sscanf(line
, f1
, &c
[0], &c
[1], &c
[2], &c
[3], &c
[4], &c
[5], &c
[6], &c
[7], &c
[8], &c
[9], &c
[10], &c
[11], &c
[12]))
774 /* Copy the B-state from the A-state */
775 copy_B_from_A(ftype
, c
);
781 warning_error(wi
, "Not enough parameters");
783 else if (nn
> nrfpA
&& nn
< nrfp
)
785 warning_error(wi
, "Too many parameters or not enough parameters for topology B");
789 warning_error(wi
, "Too many parameters");
791 for (i
= nn
; (i
< nrfp
); i
++)
797 for (i
= 0; (i
< nral
); i
++)
799 if (at
&& ((p
.a
[i
] = get_atomtype_type(alc
[i
], at
)) == NOTSET
))
801 auto message
= gmx::formatString("Unknown atomtype %s\n", alc
[i
]);
802 warning_error_and_exit(wi
, message
, FARGS
);
804 else if (bat
&& ((p
.a
[i
] = get_bond_atomtype_type(alc
[i
], bat
)) == NOTSET
))
806 auto message
= gmx::formatString("Unknown bond_atomtype %s\n", alc
[i
]);
807 warning_error_and_exit(wi
, message
, FARGS
);
810 for (i
= 0; (i
< nrfp
); i
++)
814 push_bondtype (&(bt
[ftype
]), &p
, nral
, ftype
, FALSE
, line
, wi
);
818 void push_dihedraltype(Directive d
, t_params bt
[],
819 gpp_bond_atomtype
*bat
, char *line
,
822 const char *formal
[MAXATOMLIST
+1] = {
831 const char *formnl
[MAXATOMLIST
+1] = {
837 "%*s%*s%*s%*s%*s%*s",
838 "%*s%*s%*s%*s%*s%*s%*s"
840 const char *formlf
[MAXFORCEPARAM
] = {
846 "%lf%lf%lf%lf%lf%lf",
847 "%lf%lf%lf%lf%lf%lf%lf",
848 "%lf%lf%lf%lf%lf%lf%lf%lf",
849 "%lf%lf%lf%lf%lf%lf%lf%lf%lf",
850 "%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf",
851 "%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf",
852 "%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf",
854 int i
, ft
, ftype
, nn
, nrfp
, nrfpA
, nral
;
856 char alc
[MAXATOMLIST
+1][20];
857 double c
[MAXFORCEPARAM
];
861 /* This routine accepts dihedraltypes defined from either 2 or 4 atoms.
863 * We first check for 2 atoms with the 3th column being an integer
864 * defining the type. If this isn't the case, we try it with 4 atoms
865 * and the 5th column defining the dihedral type.
867 nn
= sscanf(line
, formal
[4], alc
[0], alc
[1], alc
[2], alc
[3], alc
[4]);
868 if (nn
>= 3 && strlen(alc
[2]) == 1 && isdigit(alc
[2][0]))
871 ft
= strtol(alc
[nral
], nullptr, 10);
872 /* Move atom types around a bit and use 'X' for wildcard atoms
873 * to create a 4-atom dihedral definition with arbitrary atoms in
876 if (alc
[2][0] == '2')
878 /* improper - the two atomtypes are 1,4. Use wildcards for 2,3 */
879 strcpy(alc
[3], alc
[1]);
880 sprintf(alc
[2], "X");
881 sprintf(alc
[1], "X");
882 /* alc[0] stays put */
886 /* proper - the two atomtypes are 2,3. Use wildcards for 1,4 */
887 sprintf(alc
[3], "X");
888 strcpy(alc
[2], alc
[1]);
889 strcpy(alc
[1], alc
[0]);
890 sprintf(alc
[0], "X");
893 else if (nn
== 5 && strlen(alc
[4]) == 1 && isdigit(alc
[4][0]))
896 ft
= strtol(alc
[nral
], nullptr, 10);
900 auto message
= gmx::formatString("Incorrect number of atomtypes for dihedral (%d instead of 2 or 4)", nn
-1);
901 warning_error(wi
, message
);
907 /* Previously, we have always overwritten parameters if e.g. a torsion
908 with the same atomtypes occurs on multiple lines. However, CHARMM and
909 some other force fields specify multiple dihedrals over some bonds,
910 including cosines with multiplicity 6 and somethimes even higher.
911 Thus, they cannot be represented with Ryckaert-Bellemans terms.
912 To add support for these force fields, Dihedral type 9 is identical to
913 normal proper dihedrals, but repeated entries are allowed.
920 bAllowRepeat
= FALSE
;
924 ftype
= ifunc_index(d
, ft
);
926 nrfpA
= interaction_function
[ftype
].nrfpA
;
928 strcpy(f1
, formnl
[nral
]);
929 strcat(f1
, formlf
[nrfp
-1]);
931 /* Check number of parameters given */
932 if ((nn
= sscanf(line
, f1
, &c
[0], &c
[1], &c
[2], &c
[3], &c
[4], &c
[5], &c
[6], &c
[7], &c
[8], &c
[9], &c
[10], &c
[11]))
937 /* Copy the B-state from the A-state */
938 copy_B_from_A(ftype
, c
);
944 warning_error(wi
, "Not enough parameters");
946 else if (nn
> nrfpA
&& nn
< nrfp
)
948 warning_error(wi
, "Too many parameters or not enough parameters for topology B");
952 warning_error(wi
, "Too many parameters");
954 for (i
= nn
; (i
< nrfp
); i
++)
961 for (i
= 0; (i
< 4); i
++)
963 if (!strcmp(alc
[i
], "X"))
969 if ((p
.a
[i
] = get_bond_atomtype_type(alc
[i
], bat
)) == NOTSET
)
971 auto message
= gmx::formatString("Unknown bond_atomtype %s", alc
[i
]);
972 warning_error_and_exit(wi
, message
, FARGS
);
976 for (i
= 0; (i
< nrfp
); i
++)
980 /* Always use 4 atoms here, since we created two wildcard atoms
981 * if there wasn't of them 4 already.
983 push_bondtype (&(bt
[ftype
]), &p
, 4, ftype
, bAllowRepeat
, line
, wi
);
987 void push_nbt(Directive d
, t_nbparam
**nbt
, gpp_atomtype
*atype
,
988 char *pline
, int nb_funct
,
992 const char *form3
= "%*s%*s%*s%lf%lf%lf";
993 const char *form4
= "%*s%*s%*s%lf%lf%lf%lf";
994 const char *form5
= "%*s%*s%*s%lf%lf%lf%lf%lf";
996 int i
, f
, n
, ftype
, nrfp
;
1003 if (sscanf (pline
, "%s%s%d", a0
, a1
, &f
) != 3)
1009 ftype
= ifunc_index(d
, f
);
1011 if (ftype
!= nb_funct
)
1013 auto message
= gmx::formatString("Trying to add %s while the default nonbond type is %s",
1014 interaction_function
[ftype
].longname
,
1015 interaction_function
[nb_funct
].longname
);
1016 warning_error(wi
, message
);
1020 /* Get the force parameters */
1022 if (ftype
== F_LJ14
)
1024 n
= sscanf(pline
, form4
, &c
[0], &c
[1], &c
[2], &c
[3]);
1030 /* When the B topology parameters are not set,
1031 * copy them from topology A
1033 GMX_ASSERT(nrfp
<= 4, "LJ-14 cannot have more than 4 parameters");
1034 for (i
= n
; i
< nrfp
; i
++)
1039 else if (ftype
== F_LJC14_Q
)
1041 n
= sscanf(pline
, form5
, &c
[0], &c
[1], &c
[2], &c
[3], &dum
);
1044 incorrect_n_param(wi
);
1050 if (sscanf(pline
, form3
, &c
[0], &c
[1], &dum
) != 2)
1052 incorrect_n_param(wi
);
1058 if (sscanf(pline
, form4
, &c
[0], &c
[1], &c
[2], &dum
) != 3)
1060 incorrect_n_param(wi
);
1066 auto message
= gmx::formatString("Number of force parameters for nonbonded interactions is %d", nrfp
);
1067 warning_error_and_exit(wi
, message
, FARGS
);
1069 for (i
= 0; (i
< nrfp
); i
++)
1074 /* Put the parameters in the matrix */
1075 if ((ai
= get_atomtype_type (a0
, atype
)) == NOTSET
)
1077 auto message
= gmx::formatString("Atomtype %s not found", a0
);
1078 warning_error_and_exit(wi
, message
, FARGS
);
1080 if ((aj
= get_atomtype_type (a1
, atype
)) == NOTSET
)
1082 auto message
= gmx::formatString("Atomtype %s not found", a1
);
1083 warning_error_and_exit(wi
, message
, FARGS
);
1085 nbp
= &(nbt
[std::max(ai
, aj
)][std::min(ai
, aj
)]);
1090 for (i
= 0; i
< nrfp
; i
++)
1092 bId
= bId
&& (nbp
->c
[i
] == cr
[i
]);
1096 auto message
= gmx::formatString("Overriding non-bonded parameters,");
1097 warning(wi
, message
);
1098 fprintf(stderr
, " old:");
1099 for (i
= 0; i
< nrfp
; i
++)
1101 fprintf(stderr
, " %g", nbp
->c
[i
]);
1103 fprintf(stderr
, " new\n%s\n", pline
);
1107 for (i
= 0; i
< nrfp
; i
++)
1114 push_cmaptype(Directive d
, t_params bt
[], int nral
, gpp_atomtype
*at
,
1115 gpp_bond_atomtype
*bat
, char *line
,
1118 const char *formal
= "%s%s%s%s%s%s%s%s%n";
1120 int i
, ft
, ftype
, nn
, nrfp
, nrfpA
, nrfpB
;
1121 int start
, nchar_consumed
;
1122 int nxcmap
, nycmap
, ncmap
, read_cmap
, sl
, nct
;
1123 char s
[20], alc
[MAXATOMLIST
+2][20];
1126 /* Keep the compiler happy */
1130 GMX_ASSERT(nral
== 5, "CMAP requires 5 atoms per interaction");
1132 /* Here we can only check for < 8 */
1133 if ((nn
= sscanf(line
, formal
, alc
[0], alc
[1], alc
[2], alc
[3], alc
[4], alc
[5], alc
[6], alc
[7], &nchar_consumed
)) < nral
+3)
1135 auto message
= gmx::formatString("Incorrect number of atomtypes for cmap (%d instead of 5)", nn
-1);
1136 warning_error(wi
, message
);
1139 start
+= nchar_consumed
;
1141 ft
= strtol(alc
[nral
], nullptr, 10);
1142 nxcmap
= strtol(alc
[nral
+1], nullptr, 10);
1143 nycmap
= strtol(alc
[nral
+2], nullptr, 10);
1145 /* Check for equal grid spacing in x and y dims */
1146 if (nxcmap
!= nycmap
)
1148 auto message
= gmx::formatString("Not the same grid spacing in x and y for cmap grid: x=%d, y=%d", nxcmap
, nycmap
);
1149 warning_error(wi
, message
);
1152 ncmap
= nxcmap
*nycmap
;
1153 ftype
= ifunc_index(d
, ft
);
1154 nrfpA
= strtol(alc
[6], nullptr, 10)*strtol(alc
[6], nullptr, 10);
1155 nrfpB
= strtol(alc
[7], nullptr, 10)*strtol(alc
[7], nullptr, 10);
1158 /* Allocate memory for the CMAP grid */
1159 bt
[F_CMAP
].ncmap
+= nrfp
;
1160 srenew(bt
[F_CMAP
].cmap
, bt
[F_CMAP
].ncmap
);
1162 /* Read in CMAP parameters */
1164 for (i
= 0; i
< ncmap
; i
++)
1166 while (isspace(*(line
+start
+sl
)))
1170 nn
= sscanf(line
+start
+sl
, " %s ", s
);
1172 bt
[F_CMAP
].cmap
[i
+(bt
[F_CMAP
].ncmap
)-nrfp
] = strtod(s
, nullptr);
1180 auto message
= gmx::formatString("Error in reading cmap parameter for angle %s %s %s %s %s", alc
[0], alc
[1], alc
[2], alc
[3], alc
[4]);
1181 warning_error(wi
, message
);
1186 /* Check do that we got the number of parameters we expected */
1187 if (read_cmap
== nrfpA
)
1189 for (i
= 0; i
< ncmap
; i
++)
1191 bt
[F_CMAP
].cmap
[i
+ncmap
] = bt
[F_CMAP
].cmap
[i
];
1196 if (read_cmap
< nrfpA
)
1198 warning_error(wi
, "Not enough cmap parameters");
1200 else if (read_cmap
> nrfpA
&& read_cmap
< nrfp
)
1202 warning_error(wi
, "Too many cmap parameters or not enough parameters for topology B");
1204 else if (read_cmap
> nrfp
)
1206 warning_error(wi
, "Too many cmap parameters");
1211 /* Set grid spacing and the number of grids (we assume these numbers to be the same for all grids
1212 * so we can safely assign them each time
1214 bt
[F_CMAP
].grid_spacing
= nxcmap
; /* Or nycmap, they need to be equal */
1215 bt
[F_CMAP
].nc
= bt
[F_CMAP
].nc
+ 1; /* Since we are incrementing here, we need to subtract later, see (*****) */
1216 nct
= (nral
+1) * bt
[F_CMAP
].nc
;
1218 /* Allocate memory for the cmap_types information */
1219 srenew(bt
[F_CMAP
].cmap_types
, nct
);
1221 for (i
= 0; (i
< nral
); i
++)
1223 if (at
&& ((p
.a
[i
] = get_bond_atomtype_type(alc
[i
], bat
)) == NOTSET
))
1225 auto message
= gmx::formatString("Unknown atomtype %s\n", alc
[i
]);
1226 warning_error(wi
, message
);
1228 else if (bat
&& ((p
.a
[i
] = get_bond_atomtype_type(alc
[i
], bat
)) == NOTSET
))
1230 auto message
= gmx::formatString("Unknown bond_atomtype %s\n", alc
[i
]);
1231 warning_error(wi
, message
);
1234 /* Assign a grid number to each cmap_type */
1235 bt
[F_CMAP
].cmap_types
[bt
[F_CMAP
].nct
++] = get_bond_atomtype_type(alc
[i
], bat
);
1238 /* Assign a type number to this cmap */
1239 bt
[F_CMAP
].cmap_types
[bt
[F_CMAP
].nct
++] = bt
[F_CMAP
].nc
-1; /* Since we inremented earlier, we need to subtrac here, to get the types right (****) */
1241 /* Check for the correct number of atoms (again) */
1242 if (bt
[F_CMAP
].nct
!= nct
)
1244 auto message
= gmx::formatString("Incorrect number of atom types (%d) in cmap type %d\n", nct
, bt
[F_CMAP
].nc
);
1245 warning_error(wi
, message
);
1248 /* Is this correct?? */
1249 for (i
= 0; i
< MAXFORCEPARAM
; i
++)
1254 /* Push the bond to the bondlist */
1255 push_bondtype (&(bt
[ftype
]), &p
, nral
, ftype
, FALSE
, line
, wi
);
1259 static void push_atom_now(t_symtab
*symtab
, t_atoms
*at
, int atomnr
,
1261 int type
, char *ctype
, int ptype
,
1263 char *resname
, char *name
, real m0
, real q0
,
1264 int typeB
, char *ctypeB
, real mB
, real qB
,
1267 int j
, resind
= 0, resnr
;
1271 if (((nr
== 0) && (atomnr
!= 1)) || (nr
&& (atomnr
!= at
->nr
+1)))
1273 auto message
= gmx::formatString
1274 ("Atoms in the .top are not numbered consecutively from 1 (rather, "
1275 "atomnr = %d, while at->nr = %d)", atomnr
, at
->nr
);
1276 warning_error_and_exit(wi
, message
, FARGS
);
1279 j
= strlen(resnumberic
) - 1;
1280 if (isdigit(resnumberic
[j
]))
1286 ric
= resnumberic
[j
];
1287 if (j
== 0 || !isdigit(resnumberic
[j
-1]))
1289 auto message
= gmx::formatString("Invalid residue number '%s' for atom %d",
1290 resnumberic
, atomnr
);
1291 warning_error_and_exit(wi
, message
, FARGS
);
1294 resnr
= strtol(resnumberic
, nullptr, 10);
1298 resind
= at
->atom
[nr
-1].resind
;
1300 if (nr
== 0 || strcmp(resname
, *at
->resinfo
[resind
].name
) != 0 ||
1301 resnr
!= at
->resinfo
[resind
].nr
||
1302 ric
!= at
->resinfo
[resind
].ic
)
1312 at
->nres
= resind
+ 1;
1313 srenew(at
->resinfo
, at
->nres
);
1314 at
->resinfo
[resind
].name
= put_symtab(symtab
, resname
);
1315 at
->resinfo
[resind
].nr
= resnr
;
1316 at
->resinfo
[resind
].ic
= ric
;
1320 resind
= at
->atom
[at
->nr
-1].resind
;
1323 /* New atom instance
1324 * get new space for arrays
1326 srenew(at
->atom
, nr
+1);
1327 srenew(at
->atomname
, nr
+1);
1328 srenew(at
->atomtype
, nr
+1);
1329 srenew(at
->atomtypeB
, nr
+1);
1332 at
->atom
[nr
].type
= type
;
1333 at
->atom
[nr
].ptype
= ptype
;
1334 at
->atom
[nr
].q
= q0
;
1335 at
->atom
[nr
].m
= m0
;
1336 at
->atom
[nr
].typeB
= typeB
;
1337 at
->atom
[nr
].qB
= qB
;
1338 at
->atom
[nr
].mB
= mB
;
1340 at
->atom
[nr
].resind
= resind
;
1341 at
->atom
[nr
].atomnumber
= atomicnumber
;
1342 at
->atomname
[nr
] = put_symtab(symtab
, name
);
1343 at
->atomtype
[nr
] = put_symtab(symtab
, ctype
);
1344 at
->atomtypeB
[nr
] = put_symtab(symtab
, ctypeB
);
1348 static void push_cg(t_block
*block
, int *lastindex
, int index
, int a
)
1350 if (((block
->nr
) && (*lastindex
!= index
)) || (!block
->nr
))
1352 /* add a new block */
1354 srenew(block
->index
, block
->nr
+1);
1356 block
->index
[block
->nr
] = a
+ 1;
1360 void push_atom(t_symtab
*symtab
, t_block
*cgs
,
1361 t_atoms
*at
, gpp_atomtype
*atype
, char *line
, int *lastcg
,
1365 int cgnumber
, atomnr
, type
, typeB
, nscan
;
1366 char id
[STRLEN
], ctype
[STRLEN
], ctypeB
[STRLEN
],
1367 resnumberic
[STRLEN
], resname
[STRLEN
], name
[STRLEN
], check
[STRLEN
];
1368 double m
, q
, mb
, qb
;
1369 real m0
, q0
, mB
, qB
;
1371 /* Make a shortcut for writing in this molecule */
1374 /* Fixed parameters */
1375 if (sscanf(line
, "%s%s%s%s%s%d",
1376 id
, ctype
, resnumberic
, resname
, name
, &cgnumber
) != 6)
1381 sscanf(id
, "%d", &atomnr
);
1382 if ((type
= get_atomtype_type(ctype
, atype
)) == NOTSET
)
1384 auto message
= gmx::formatString("Atomtype %s not found", ctype
);
1385 warning_error_and_exit(wi
, message
, FARGS
);
1387 ptype
= get_atomtype_ptype(type
, atype
);
1389 /* Set default from type */
1390 q0
= get_atomtype_qA(type
, atype
);
1391 m0
= get_atomtype_massA(type
, atype
);
1396 /* Optional parameters */
1397 nscan
= sscanf(line
, "%*s%*s%*s%*s%*s%*s%lf%lf%s%lf%lf%s",
1398 &q
, &m
, ctypeB
, &qb
, &mb
, check
);
1400 /* Nasty switch that falls thru all the way down! */
1409 if ((typeB
= get_atomtype_type(ctypeB
, atype
)) == NOTSET
)
1411 auto message
= gmx::formatString("Atomtype %s not found", ctypeB
);
1412 warning_error_and_exit(wi
, message
, FARGS
);
1414 qB
= get_atomtype_qA(typeB
, atype
);
1415 mB
= get_atomtype_massA(typeB
, atype
);
1424 warning_error(wi
, "Too many parameters");
1432 push_cg(cgs
, lastcg
, cgnumber
, nr
);
1434 push_atom_now(symtab
, at
, atomnr
, get_atomtype_atomnumber(type
, atype
),
1435 type
, ctype
, ptype
, resnumberic
,
1436 resname
, name
, m0
, q0
, typeB
,
1437 typeB
== type
? ctype
: ctypeB
, mB
, qB
, wi
);
1440 void push_molt(t_symtab
*symtab
, int *nmol
, t_molinfo
**mol
, char *line
,
1447 if ((sscanf(line
, "%s%d", type
, &nrexcl
)) != 2)
1449 warning_error(wi
, "Expected a molecule type name and nrexcl");
1452 /* Test if this moleculetype overwrites another */
1456 if (strcmp(*((*mol
)[i
].name
), type
) == 0)
1458 auto message
= gmx::formatString("moleculetype %s is redefined", type
);
1459 warning_error_and_exit(wi
, message
, FARGS
);
1465 srenew(*mol
, *nmol
);
1466 newmol
= &((*mol
)[*nmol
-1]);
1467 init_molinfo(newmol
);
1469 /* Fill in the values */
1470 newmol
->name
= put_symtab(symtab
, type
);
1471 newmol
->nrexcl
= nrexcl
;
1472 newmol
->excl_set
= FALSE
;
1475 static bool default_nb_params(int ftype
, t_params bt
[], t_atoms
*at
,
1476 t_param
*p
, int c_start
, bool bB
, bool bGenPairs
)
1478 int i
, j
, ti
, tj
, ntype
;
1480 t_param
*pi
= nullptr;
1481 int nr
= bt
[ftype
].nr
;
1482 int nral
= NRAL(ftype
);
1483 int nrfp
= interaction_function
[ftype
].nrfpA
;
1484 int nrfpB
= interaction_function
[ftype
].nrfpB
;
1486 if ((!bB
&& nrfp
== 0) || (bB
&& nrfpB
== 0))
1494 /* First test the generated-pair position to save
1495 * time when we have 1000*1000 entries for e.g. OPLS...
1497 ntype
= static_cast<int>(std::sqrt(static_cast<double>(nr
)));
1498 GMX_ASSERT(ntype
* ntype
== nr
, "Number of pairs of generated non-bonded parameters should be a perfect square");
1501 ti
= at
->atom
[p
->a
[0]].typeB
;
1502 tj
= at
->atom
[p
->a
[1]].typeB
;
1506 ti
= at
->atom
[p
->a
[0]].type
;
1507 tj
= at
->atom
[p
->a
[1]].type
;
1509 pi
= &(bt
[ftype
].param
[ntype
*ti
+tj
]);
1510 bFound
= ((ti
== pi
->a
[0]) && (tj
== pi
->a
[1]));
1513 /* Search explicitly if we didnt find it */
1516 for (i
= 0; ((i
< nr
) && !bFound
); i
++)
1518 pi
= &(bt
[ftype
].param
[i
]);
1521 for (j
= 0; ((j
< nral
) &&
1522 (at
->atom
[p
->a
[j
]].typeB
== pi
->a
[j
])); j
++)
1529 for (j
= 0; ((j
< nral
) &&
1530 (at
->atom
[p
->a
[j
]].type
== pi
->a
[j
])); j
++)
1535 bFound
= (j
== nral
);
1543 if (nrfp
+nrfpB
> MAXFORCEPARAM
)
1545 gmx_incons("Too many force parameters");
1547 for (j
= c_start
; (j
< nrfpB
); j
++)
1549 p
->c
[nrfp
+j
] = pi
->c
[j
];
1554 for (j
= c_start
; (j
< nrfp
); j
++)
1562 for (j
= c_start
; (j
< nrfp
); j
++)
1570 static bool default_cmap_params(t_params bondtype
[],
1571 t_atoms
*at
, gpp_atomtype
*atype
,
1572 t_param
*p
, bool bB
,
1573 int *cmap_type
, int *nparam_def
,
1576 int i
, nparam_found
;
1578 bool bFound
= FALSE
;
1583 /* Match the current cmap angle against the list of cmap_types */
1584 for (i
= 0; i
< bondtype
[F_CMAP
].nct
&& !bFound
; i
+= 6)
1593 (get_atomtype_batype(at
->atom
[p
->a
[0]].type
, atype
) == bondtype
[F_CMAP
].cmap_types
[i
]) &&
1594 (get_atomtype_batype(at
->atom
[p
->a
[1]].type
, atype
) == bondtype
[F_CMAP
].cmap_types
[i
+1]) &&
1595 (get_atomtype_batype(at
->atom
[p
->a
[2]].type
, atype
) == bondtype
[F_CMAP
].cmap_types
[i
+2]) &&
1596 (get_atomtype_batype(at
->atom
[p
->a
[3]].type
, atype
) == bondtype
[F_CMAP
].cmap_types
[i
+3]) &&
1597 (get_atomtype_batype(at
->atom
[p
->a
[4]].type
, atype
) == bondtype
[F_CMAP
].cmap_types
[i
+4]))
1599 /* Found cmap torsion */
1601 ct
= bondtype
[F_CMAP
].cmap_types
[i
+5];
1607 /* If we did not find a matching type for this cmap torsion */
1610 auto message
= gmx::formatString("Unknown cmap torsion between atoms %d %d %d %d %d",
1611 p
->a
[0]+1, p
->a
[1]+1, p
->a
[2]+1, p
->a
[3]+1, p
->a
[4]+1);
1612 warning_error_and_exit(wi
, message
, FARGS
);
1615 *nparam_def
= nparam_found
;
1621 /* Returns the number of exact atom type matches, i.e. non wild-card matches,
1622 * returns -1 when there are no matches at all.
1624 static int natom_match(t_param
*pi
,
1625 int type_i
, int type_j
, int type_k
, int type_l
,
1626 const gpp_atomtype
* atype
)
1628 if ((pi
->ai() == -1 || get_atomtype_batype(type_i
, atype
) == pi
->ai()) &&
1629 (pi
->aj() == -1 || get_atomtype_batype(type_j
, atype
) == pi
->aj()) &&
1630 (pi
->ak() == -1 || get_atomtype_batype(type_k
, atype
) == pi
->ak()) &&
1631 (pi
->al() == -1 || get_atomtype_batype(type_l
, atype
) == pi
->al()))
1634 (pi
->ai() == -1 ? 0 : 1) +
1635 (pi
->aj() == -1 ? 0 : 1) +
1636 (pi
->ak() == -1 ? 0 : 1) +
1637 (pi
->al() == -1 ? 0 : 1);
1645 static bool default_params(int ftype
, t_params bt
[],
1646 t_atoms
*at
, gpp_atomtype
*atype
,
1647 t_param
*p
, bool bB
,
1648 t_param
**param_def
,
1653 t_param
*pi
= nullptr;
1654 t_param
*pj
= nullptr;
1655 int nr
= bt
[ftype
].nr
;
1656 int nral
= NRAL(ftype
);
1657 int nrfpA
= interaction_function
[ftype
].nrfpA
;
1658 int nrfpB
= interaction_function
[ftype
].nrfpB
;
1660 if ((!bB
&& nrfpA
== 0) || (bB
&& nrfpB
== 0))
1668 if (ftype
== F_PDIHS
|| ftype
== F_RBDIHS
|| ftype
== F_IDIHS
|| ftype
== F_PIDIHS
)
1670 int nmatch_max
= -1;
1674 /* For dihedrals we allow wildcards. We choose the first type
1675 * that has the most real matches, i.e. non-wildcard matches.
1677 for (t
= 0; ((t
< nr
) && nmatch_max
< 4); t
++)
1682 pt
= &(bt
[ftype
].param
[t
]);
1685 nmatch
= natom_match(pt
, at
->atom
[p
->ai()].typeB
, at
->atom
[p
->aj()].typeB
, at
->atom
[p
->ak()].typeB
, at
->atom
[p
->al()].typeB
, atype
);
1689 nmatch
= natom_match(pt
, at
->atom
[p
->ai()].type
, at
->atom
[p
->aj()].type
, at
->atom
[p
->ak()].type
, at
->atom
[p
->al()].type
, atype
);
1691 if (nmatch
> nmatch_max
)
1693 nmatch_max
= nmatch
;
1703 pi
= &(bt
[ftype
].param
[i
]);
1706 /* Find additional matches for this dihedral - necessary
1708 * The rule in that case is that additional matches
1709 * HAVE to be on adjacent lines!
1712 /* Continue from current i value */
1713 for (j
= i
+ 2; j
< nr
&& bSame
; j
+= 2)
1715 pj
= &(bt
[ftype
].param
[j
]);
1716 bSame
= (pi
->ai() == pj
->ai() && pi
->aj() == pj
->aj() && pi
->ak() == pj
->ak() && pi
->al() == pj
->al());
1721 /* nparam_found will be increased as long as the numbers match */
1725 else /* Not a dihedral */
1729 for (i
= 0; ((i
< nr
) && !bFound
); i
++)
1731 pi
= &(bt
[ftype
].param
[i
]);
1734 for (j
= 0; ((j
< nral
) &&
1735 (get_atomtype_batype(at
->atom
[p
->a
[j
]].typeB
, atype
) == pi
->a
[j
])); j
++)
1742 for (j
= 0; ((j
< nral
) &&
1743 (get_atomtype_batype(at
->atom
[p
->a
[j
]].type
, atype
) == pi
->a
[j
])); j
++)
1748 bFound
= (j
== nral
);
1757 *nparam_def
= nparam_found
;
1764 void push_bond(Directive d
, t_params bondtype
[], t_params bond
[],
1765 t_atoms
*at
, gpp_atomtype
*atype
, char *line
,
1766 bool bBonded
, bool bGenPairs
, real fudgeQQ
,
1767 bool bZero
, bool *bWarn_copy_A_B
,
1770 const char *aaformat
[MAXATOMLIST
] = {
1778 const char *asformat
[MAXATOMLIST
] = {
1783 "%*s%*s%*s%*s%*s%*s",
1784 "%*s%*s%*s%*s%*s%*s%*s"
1786 const char *ccformat
= "%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf%lf";
1787 int nr
, i
, j
, nral
, nral_fmt
, nread
, ftype
;
1788 char format
[STRLEN
];
1789 /* One force parameter more, so we can check if we read too many */
1790 double cc
[MAXFORCEPARAM
+1];
1791 int aa
[MAXATOMLIST
+1];
1792 t_param param
, *param_defA
, *param_defB
;
1793 bool bFoundA
= FALSE
, bFoundB
= FALSE
, bDef
, bPert
, bSwapParity
= FALSE
;
1794 int nparam_defA
, nparam_defB
;
1796 nparam_defA
= nparam_defB
= 0;
1798 ftype
= ifunc_index(d
, 1);
1800 for (j
= 0; j
< MAXATOMLIST
; j
++)
1804 bDef
= (NRFP(ftype
) > 0);
1806 if (ftype
== F_SETTLE
)
1808 /* SETTLE acts on 3 atoms, but the topology format only specifies
1809 * the first atom (for historical reasons).
1818 nread
= sscanf(line
, aaformat
[nral_fmt
-1],
1819 &aa
[0], &aa
[1], &aa
[2], &aa
[3], &aa
[4], &aa
[5]);
1821 if (ftype
== F_SETTLE
)
1828 if (nread
< nral_fmt
)
1833 else if (nread
> nral_fmt
)
1835 /* this is a hack to allow for virtual sites with swapped parity */
1836 bSwapParity
= (aa
[nral
] < 0);
1839 aa
[nral
] = -aa
[nral
];
1841 ftype
= ifunc_index(d
, aa
[nral
]);
1850 auto message
= gmx::formatString("Negative function types only allowed for %s and %s",
1851 interaction_function
[F_VSITE3FAD
].longname
,
1852 interaction_function
[F_VSITE3OUT
].longname
);
1853 warning_error_and_exit(wi
, message
, FARGS
);
1859 /* Check for double atoms and atoms out of bounds */
1860 for (i
= 0; (i
< nral
); i
++)
1862 if (aa
[i
] < 1 || aa
[i
] > at
->nr
)
1864 auto message
= gmx::formatString
1865 ("Atom index (%d) in %s out of bounds (1-%d).\n"
1866 "This probably means that you have inserted topology section \"%s\"\n"
1867 "in a part belonging to a different molecule than you intended to.\n"
1868 "In that case move the \"%s\" section to the right molecule.",
1869 aa
[i
], dir2str(d
), at
->nr
, dir2str(d
), dir2str(d
));
1870 warning_error_and_exit(wi
, message
, FARGS
);
1872 for (j
= i
+1; (j
< nral
); j
++)
1874 GMX_ASSERT(j
< MAXATOMLIST
+ 1, "Values from nral=NRAL() will satisfy this, we assert to keep gcc 4 happy");
1877 auto message
= gmx::formatString("Duplicate atom index (%d) in %s", aa
[i
], dir2str(d
));
1878 if (ftype
== F_ANGRES
)
1880 /* Since the angle restraints uses 2 pairs of atoms to
1881 * defines an angle between vectors, it can be useful
1882 * to use one atom twice, so we only issue a note here.
1884 warning_note(wi
, message
);
1888 warning_error(wi
, message
);
1894 /* default force parameters */
1895 for (j
= 0; (j
< MAXATOMLIST
); j
++)
1897 param
.a
[j
] = aa
[j
]-1;
1899 for (j
= 0; (j
< MAXFORCEPARAM
); j
++)
1904 /* Get force params for normal and free energy perturbation
1905 * studies, as determined by types!
1910 bFoundA
= default_params(ftype
, bondtype
, at
, atype
, ¶m
, FALSE
, ¶m_defA
, &nparam_defA
);
1913 /* Copy the A-state and B-state default parameters. */
1914 GMX_ASSERT(NRFPA(ftype
)+NRFPB(ftype
) <= MAXFORCEPARAM
, "Bonded interactions may have at most 12 parameters");
1915 for (j
= 0; (j
< NRFPA(ftype
)+NRFPB(ftype
)); j
++)
1917 param
.c
[j
] = param_defA
->c
[j
];
1920 bFoundB
= default_params(ftype
, bondtype
, at
, atype
, ¶m
, TRUE
, ¶m_defB
, &nparam_defB
);
1923 /* Copy only the B-state default parameters */
1924 for (j
= NRFPA(ftype
); (j
< NRFP(ftype
)); j
++)
1926 param
.c
[j
] = param_defB
->c
[j
];
1930 else if (ftype
== F_LJ14
)
1932 bFoundA
= default_nb_params(ftype
, bondtype
, at
, ¶m
, 0, FALSE
, bGenPairs
);
1933 bFoundB
= default_nb_params(ftype
, bondtype
, at
, ¶m
, 0, TRUE
, bGenPairs
);
1935 else if (ftype
== F_LJC14_Q
)
1937 param
.c
[0] = fudgeQQ
;
1938 /* Fill in the A-state charges as default parameters */
1939 param
.c
[1] = at
->atom
[param
.a
[0]].q
;
1940 param
.c
[2] = at
->atom
[param
.a
[1]].q
;
1941 /* The default LJ parameters are the standard 1-4 parameters */
1942 bFoundA
= default_nb_params(F_LJ14
, bondtype
, at
, ¶m
, 3, FALSE
, bGenPairs
);
1945 else if (ftype
== F_LJC_PAIRS_NB
)
1947 /* Defaults are not supported here */
1953 gmx_incons("Unknown function type in push_bond");
1956 if (nread
> nral_fmt
)
1958 /* Manually specified parameters - in this case we discard multiple torsion info! */
1960 strcpy(format
, asformat
[nral_fmt
-1]);
1961 strcat(format
, ccformat
);
1963 nread
= sscanf(line
, format
, &cc
[0], &cc
[1], &cc
[2], &cc
[3], &cc
[4], &cc
[5],
1964 &cc
[6], &cc
[7], &cc
[8], &cc
[9], &cc
[10], &cc
[11], &cc
[12]);
1966 if ((nread
== NRFPA(ftype
)) && (NRFPB(ftype
) != 0))
1968 /* We only have to issue a warning if these atoms are perturbed! */
1970 for (j
= 0; (j
< nral
); j
++)
1972 bPert
= bPert
|| PERTURBED(at
->atom
[param
.a
[j
]]);
1975 if (bPert
&& *bWarn_copy_A_B
)
1977 auto message
= gmx::formatString("Some parameters for bonded interaction involving "
1978 "perturbed atoms are specified explicitly in "
1979 "state A, but not B - copying A to B");
1980 warning(wi
, message
);
1981 *bWarn_copy_A_B
= FALSE
;
1984 /* If only the A parameters were specified, copy them to the B state */
1985 /* The B-state parameters correspond to the first nrfpB
1986 * A-state parameters.
1988 for (j
= 0; (j
< NRFPB(ftype
)); j
++)
1990 cc
[nread
++] = cc
[j
];
1994 /* If nread was 0 or EOF, no parameters were read => use defaults.
1995 * If nread was nrfpA we copied above so nread=nrfp.
1996 * If nread was nrfp we are cool.
1997 * For F_LJC14_Q we allow supplying fudgeQQ only.
1998 * Anything else is an error!
2000 if ((nread
!= 0) && (nread
!= EOF
) && (nread
!= NRFP(ftype
)) &&
2001 !(ftype
== F_LJC14_Q
&& nread
== 1))
2003 auto message
= gmx::formatString
2004 ("Incorrect number of parameters - found %d, expected %d "
2005 "or %d for %s (after the function type).",
2006 nread
, NRFPA(ftype
), NRFP(ftype
), interaction_function
[ftype
].longname
);
2007 warning_error_and_exit(wi
, message
, FARGS
);
2010 for (j
= 0; (j
< nread
); j
++)
2015 /* Check whether we have to use the defaults */
2016 if (nread
== NRFP(ftype
))
2025 /* nread now holds the number of force parameters read! */
2030 /* When we have multiple terms it would be very dangerous to allow perturbations to a different atom type! */
2031 if (ftype
== F_PDIHS
)
2033 if ((nparam_defA
!= nparam_defB
) || ((nparam_defA
> 1 || nparam_defB
> 1) && (param_defA
!= param_defB
)))
2036 gmx::formatString("Cannot automatically perturb a torsion with multiple terms to different form.\n"
2037 "Please specify perturbed parameters manually for this torsion in your topology!");
2038 warning_error(wi
, message
);
2042 if (nread
> 0 && nread
< NRFPA(ftype
))
2044 /* Issue an error, do not use defaults */
2045 auto message
= gmx::formatString("Not enough parameters, there should be at least %d (or 0 for defaults)", NRFPA(ftype
));
2046 warning_error(wi
, message
);
2049 if (nread
== 0 || nread
== EOF
)
2053 if (interaction_function
[ftype
].flags
& IF_VSITE
)
2055 /* set them to NOTSET, will be calculated later */
2056 for (j
= 0; (j
< MAXFORCEPARAM
); j
++)
2058 param
.c
[j
] = NOTSET
;
2063 param
.c1() = -1; /* flag to swap parity of vsite construction */
2070 fprintf(stderr
, "NOTE: No default %s types, using zeroes\n",
2071 interaction_function
[ftype
].longname
);
2075 auto message
= gmx::formatString("No default %s types", interaction_function
[ftype
].longname
);
2076 warning_error(wi
, message
);
2087 param
.c0() = 360 - param
.c0();
2090 param
.c2() = -param
.c2();
2097 /* We only have to issue a warning if these atoms are perturbed! */
2099 for (j
= 0; (j
< nral
); j
++)
2101 bPert
= bPert
|| PERTURBED(at
->atom
[param
.a
[j
]]);
2106 auto message
= gmx::formatString("No default %s types for perturbed atoms, "
2107 "using normal values", interaction_function
[ftype
].longname
);
2108 warning(wi
, message
);
2114 if ((ftype
== F_PDIHS
|| ftype
== F_ANGRES
|| ftype
== F_ANGRESZ
)
2115 && param
.c
[5] != param
.c
[2])
2117 auto message
= gmx::formatString("%s multiplicity can not be perturbed %f!=%f",
2118 interaction_function
[ftype
].longname
,
2119 param
.c
[2], param
.c
[5]);
2120 warning_error_and_exit(wi
, message
, FARGS
);
2123 if (IS_TABULATED(ftype
) && param
.c
[2] != param
.c
[0])
2125 auto message
= gmx::formatString("%s table number can not be perturbed %d!=%d",
2126 interaction_function
[ftype
].longname
,
2127 gmx::roundToInt(param
.c
[0]), gmx::roundToInt(param
.c
[2]));
2128 warning_error_and_exit(wi
, message
, FARGS
);
2131 /* Dont add R-B dihedrals where all parameters are zero (no interaction) */
2132 if (ftype
== F_RBDIHS
)
2135 for (i
= 0; i
< NRFP(ftype
); i
++)
2137 if (param
.c
[i
] != 0)
2148 /* Put the values in the appropriate arrays */
2149 add_param_to_list (&bond
[ftype
], ¶m
);
2151 /* Push additional torsions from FF for ftype==9 if we have them.
2152 * We have already checked that the A/B states do not differ in this case,
2153 * so we do not have to double-check that again, or the vsite stuff.
2154 * In addition, those torsions cannot be automatically perturbed.
2156 if (bDef
&& ftype
== F_PDIHS
)
2158 for (i
= 1; i
< nparam_defA
; i
++)
2160 /* Advance pointer! */
2162 for (j
= 0; (j
< NRFPA(ftype
)+NRFPB(ftype
)); j
++)
2164 param
.c
[j
] = param_defA
->c
[j
];
2166 /* And push the next term for this torsion */
2167 add_param_to_list (&bond
[ftype
], ¶m
);
2172 void push_cmap(Directive d
, t_params bondtype
[], t_params bond
[],
2173 t_atoms
*at
, gpp_atomtype
*atype
, char *line
,
2176 const char *aaformat
[MAXATOMLIST
+1] =
2187 int i
, j
, ftype
, nral
, nread
, ncmap_params
;
2189 int aa
[MAXATOMLIST
+1];
2193 ftype
= ifunc_index(d
, 1);
2197 nread
= sscanf(line
, aaformat
[nral
-1],
2198 &aa
[0], &aa
[1], &aa
[2], &aa
[3], &aa
[4], &aa
[5]);
2205 else if (nread
== nral
)
2207 ftype
= ifunc_index(d
, 1);
2210 /* Check for double atoms and atoms out of bounds */
2211 for (i
= 0; i
< nral
; i
++)
2213 if (aa
[i
] < 1 || aa
[i
] > at
->nr
)
2215 auto message
= gmx::formatString
2216 ("Atom index (%d) in %s out of bounds (1-%d).\n"
2217 "This probably means that you have inserted topology section \"%s\"\n"
2218 "in a part belonging to a different molecule than you intended to.\n"
2219 "In that case move the \"%s\" section to the right molecule.",
2220 aa
[i
], dir2str(d
), at
->nr
, dir2str(d
), dir2str(d
));
2221 warning_error_and_exit(wi
, message
, FARGS
);
2224 for (j
= i
+1; (j
< nral
); j
++)
2228 auto message
= gmx::formatString("Duplicate atom index (%d) in %s", aa
[i
], dir2str(d
));
2229 warning_error(wi
, message
);
2234 /* default force parameters */
2235 for (j
= 0; (j
< MAXATOMLIST
); j
++)
2237 param
.a
[j
] = aa
[j
]-1;
2239 for (j
= 0; (j
< MAXFORCEPARAM
); j
++)
2244 /* Get the cmap type for this cmap angle */
2245 bFound
= default_cmap_params(bondtype
, at
, atype
, ¶m
, FALSE
, &cmap_type
, &ncmap_params
, wi
);
2247 /* We want exactly one parameter (the cmap type in state A (currently no state B) back */
2248 if (bFound
&& ncmap_params
== 1)
2250 /* Put the values in the appropriate arrays */
2251 param
.c
[0] = cmap_type
;
2252 add_param_to_list(&bond
[ftype
], ¶m
);
2256 /* This is essentially the same check as in default_cmap_params() done one more time */
2257 auto message
= gmx::formatString("Unable to assign a cmap type to torsion %d %d %d %d and %d\n",
2258 param
.a
[0]+1, param
.a
[1]+1, param
.a
[2]+1, param
.a
[3]+1, param
.a
[4]+1);
2259 warning_error_and_exit(wi
, message
, FARGS
);
2265 void push_vsitesn(Directive d
, t_params bond
[],
2266 t_atoms
*at
, char *line
,
2270 int type
, ftype
, j
, n
, ret
, nj
, a
;
2272 double *weight
= nullptr, weight_tot
;
2275 /* default force parameters */
2276 for (j
= 0; (j
< MAXATOMLIST
); j
++)
2278 param
.a
[j
] = NOTSET
;
2280 for (j
= 0; (j
< MAXFORCEPARAM
); j
++)
2286 ret
= sscanf(ptr
, "%d%n", &a
, &n
);
2290 auto message
= gmx::formatString("Expected an atom index in section \"%s\"",
2292 warning_error_and_exit(wi
, message
, FARGS
);
2297 sscanf(ptr
, "%d%n", &type
, &n
);
2299 ftype
= ifunc_index(d
, type
);
2305 ret
= sscanf(ptr
, "%d%n", &a
, &n
);
2312 srenew(weight
, nj
+20);
2321 /* Here we use the A-state mass as a parameter.
2322 * Note that the B-state mass has no influence.
2324 weight
[nj
] = at
->atom
[atc
[nj
]].m
;
2328 ret
= sscanf(ptr
, "%lf%n", &(weight
[nj
]), &n
);
2332 auto message
= gmx::formatString
2333 ("No weight or negative weight found for vsiten "
2334 "constructing atom %d (atom index %d)",
2336 warning_error_and_exit(wi
, message
, FARGS
);
2340 auto message
= gmx::formatString("Unknown vsiten type %d", type
);
2341 warning_error_and_exit(wi
, message
, FARGS
);
2343 weight_tot
+= weight
[nj
];
2351 auto message
= gmx::formatString("Expected more than one atom index in section \"%s\"",
2353 warning_error_and_exit(wi
, message
, FARGS
);
2356 if (weight_tot
== 0)
2358 warning_error_and_exit(wi
, "The total mass of the construting atoms is zero", FARGS
);
2361 for (j
= 0; j
< nj
; j
++)
2363 param
.a
[1] = atc
[j
];
2365 param
.c
[1] = weight
[j
]/weight_tot
;
2366 /* Put the values in the appropriate arrays */
2367 add_param_to_list (&bond
[ftype
], ¶m
);
2374 void push_mol(int nrmols
, t_molinfo mols
[], char *pline
, int *whichmol
,
2380 if (sscanf(pline
, "%s%d", type
, nrcopies
) != 2)
2386 /* Search moleculename.
2387 * Here we originally only did case insensitive matching. But because
2388 * some PDB files can have many chains and use case to generate more
2389 * chain-identifiers, which in turn end up in our moleculetype name,
2390 * we added support for case-sensitivity.
2396 for (int i
= 0; i
< nrmols
; i
++)
2398 if (strcmp(type
, *(mols
[i
].name
)) == 0)
2403 if (gmx_strcasecmp(type
, *(mols
[i
].name
)) == 0)
2412 // select the case sensitive match
2413 *whichmol
= matchcs
;
2417 // avoid matching case-insensitive when we have multiple matches
2420 auto message
= gmx::formatString
2421 ("For moleculetype '%s' in [ system ] %d case insensitive "
2422 "matches, but %d case sensitive matches were found. Check "
2423 "the case of the characters in the moleculetypes.",
2425 warning_error_and_exit(wi
, message
, FARGS
);
2429 // select the unique case insensitive match
2430 *whichmol
= matchci
;
2434 auto message
= gmx::formatString("No such moleculetype %s", type
);
2435 warning_error_and_exit(wi
, message
, FARGS
);
2440 void push_excl(char *line
, gmx::ExclusionBlocks
*b2
, warninp
*wi
)
2444 char base
[STRLEN
], format
[STRLEN
];
2446 if (sscanf(line
, "%d", &i
) == 0)
2451 if ((1 <= i
) && (i
<= b2
->nr
))
2459 strcpy(base
, "%*d");
2462 strcpy(format
, base
);
2463 strcat(format
, "%d");
2464 n
= sscanf(line
, format
, &j
);
2467 if ((1 <= j
) && (j
<= b2
->nr
))
2470 srenew(b2
->a
[i
], ++(b2
->nra
[i
]));
2471 b2
->a
[i
][b2
->nra
[i
]-1] = j
;
2472 /* also add the reverse exclusion! */
2473 srenew(b2
->a
[j
], ++(b2
->nra
[j
]));
2474 b2
->a
[j
][b2
->nra
[j
]-1] = i
;
2475 strcat(base
, "%*d");
2479 auto message
= gmx::formatString("Invalid Atomnr j: %d, b2->nr: %d\n", j
, b2
->nr
);
2480 warning_error_and_exit(wi
, message
, FARGS
);
2487 int add_atomtype_decoupled(t_symtab
*symtab
, gpp_atomtype
*at
,
2488 t_nbparam
***nbparam
, t_nbparam
***pair
)
2494 /* Define an atom type with all parameters set to zero (no interactions) */
2497 /* Type for decoupled atoms could be anything,
2498 * this should be changed automatically later when required.
2500 atom
.ptype
= eptAtom
;
2501 for (i
= 0; (i
< MAXFORCEPARAM
); i
++)
2506 nr
= add_atomtype(at
, symtab
, &atom
, "decoupled", ¶m
, -1, 0);
2508 /* Add space in the non-bonded parameters matrix */
2509 realloc_nb_params(at
, nbparam
, pair
);
2514 static void convert_pairs_to_pairsQ(t_params
*plist
,
2515 real fudgeQQ
, t_atoms
*atoms
)
2517 t_param
*paramp1
, *paramp2
, *paramnew
;
2518 int i
, j
, p1nr
, p2nr
, p2newnr
;
2520 /* Add the pair list to the pairQ list */
2521 p1nr
= plist
[F_LJ14
].nr
;
2522 p2nr
= plist
[F_LJC14_Q
].nr
;
2523 p2newnr
= p1nr
+ p2nr
;
2524 snew(paramnew
, p2newnr
);
2526 paramp1
= plist
[F_LJ14
].param
;
2527 paramp2
= plist
[F_LJC14_Q
].param
;
2529 /* Fill in the new F_LJC14_Q array with the old one. NOTE:
2530 it may be possible to just ADD the converted F_LJ14 array
2531 to the old F_LJC14_Q array, but since we have to create
2532 a new sized memory structure, better just to deep copy it all.
2535 for (i
= 0; i
< p2nr
; i
++)
2537 /* Copy over parameters */
2538 for (j
= 0; j
< 5; j
++) /* entries are 0-4 for F_LJC14_Q */
2540 paramnew
[i
].c
[j
] = paramp2
[i
].c
[j
];
2543 /* copy over atoms */
2544 for (j
= 0; j
< 2; j
++)
2546 paramnew
[i
].a
[j
] = paramp2
[i
].a
[j
];
2550 for (i
= p2nr
; i
< p2newnr
; i
++)
2554 /* Copy over parameters */
2555 paramnew
[i
].c
[0] = fudgeQQ
;
2556 paramnew
[i
].c
[1] = atoms
->atom
[paramp1
[j
].a
[0]].q
;
2557 paramnew
[i
].c
[2] = atoms
->atom
[paramp1
[j
].a
[1]].q
;
2558 paramnew
[i
].c
[3] = paramp1
[j
].c
[0];
2559 paramnew
[i
].c
[4] = paramp1
[j
].c
[1];
2561 /* copy over atoms */
2562 paramnew
[i
].a
[0] = paramp1
[j
].a
[0];
2563 paramnew
[i
].a
[1] = paramp1
[j
].a
[1];
2566 /* free the old pairlists */
2567 sfree(plist
[F_LJC14_Q
].param
);
2568 sfree(plist
[F_LJ14
].param
);
2570 /* now assign the new data to the F_LJC14_Q structure */
2571 plist
[F_LJC14_Q
].param
= paramnew
;
2572 plist
[F_LJC14_Q
].nr
= p2newnr
;
2574 /* Empty the LJ14 pairlist */
2575 plist
[F_LJ14
].nr
= 0;
2576 plist
[F_LJ14
].param
= nullptr;
2579 static void generate_LJCpairsNB(t_molinfo
*mol
, int nb_funct
, t_params
*nbp
, warninp
*wi
)
2581 int n
, ntype
, i
, j
, k
;
2588 atom
= mol
->atoms
.atom
;
2590 ntype
= static_cast<int>(std::sqrt(static_cast<double>(nbp
->nr
)));
2591 GMX_ASSERT(ntype
* ntype
== nbp
->nr
, "Number of pairs of generated non-bonded parameters should be a perfect square");
2593 for (i
= 0; i
< MAXATOMLIST
; i
++)
2595 param
.a
[i
] = NOTSET
;
2597 for (i
= 0; i
< MAXFORCEPARAM
; i
++)
2599 param
.c
[i
] = NOTSET
;
2602 /* Add a pair interaction for all non-excluded atom pairs */
2604 for (i
= 0; i
< n
; i
++)
2606 for (j
= i
+1; j
< n
; j
++)
2609 for (k
= excl
->index
[i
]; k
< excl
->index
[i
+1]; k
++)
2611 if (excl
->a
[k
] == j
)
2618 if (nb_funct
!= F_LJ
)
2620 auto message
= gmx::formatString
2621 ("Can only generate non-bonded pair interactions "
2622 "for Van der Waals type Lennard-Jones");
2623 warning_error_and_exit(wi
, message
, FARGS
);
2627 param
.c
[0] = atom
[i
].q
;
2628 param
.c
[1] = atom
[j
].q
;
2629 param
.c
[2] = nbp
->param
[ntype
*atom
[i
].type
+atom
[j
].type
].c
[0];
2630 param
.c
[3] = nbp
->param
[ntype
*atom
[i
].type
+atom
[j
].type
].c
[1];
2631 add_param_to_list(&mol
->plist
[F_LJC_PAIRS_NB
], ¶m
);
2637 static void set_excl_all(t_blocka
*excl
)
2641 /* Get rid of the current exclusions and exclude all atom pairs */
2643 excl
->nra
= nat
*nat
;
2644 srenew(excl
->a
, excl
->nra
);
2646 for (i
= 0; i
< nat
; i
++)
2649 for (j
= 0; j
< nat
; j
++)
2654 excl
->index
[nat
] = k
;
2657 static void decouple_atoms(t_atoms
*atoms
, int atomtype_decouple
,
2658 int couple_lam0
, int couple_lam1
,
2659 const char *mol_name
, warninp
*wi
)
2663 for (i
= 0; i
< atoms
->nr
; i
++)
2667 atom
= &atoms
->atom
[i
];
2669 if (atom
->qB
!= atom
->q
|| atom
->typeB
!= atom
->type
)
2671 auto message
= gmx::formatString
2672 ("Atom %d in molecule type '%s' has different A and B state "
2673 "charges and/or atom types set in the topology file as well "
2674 "as through the mdp option '%s'. You can not use both "
2675 "these methods simultaneously.",
2676 i
+ 1, mol_name
, "couple-moltype");
2677 warning_error_and_exit(wi
, message
, FARGS
);
2680 if (couple_lam0
== ecouplamNONE
|| couple_lam0
== ecouplamVDW
)
2684 if (couple_lam0
== ecouplamNONE
|| couple_lam0
== ecouplamQ
)
2686 atom
->type
= atomtype_decouple
;
2688 if (couple_lam1
== ecouplamNONE
|| couple_lam1
== ecouplamVDW
)
2692 if (couple_lam1
== ecouplamNONE
|| couple_lam1
== ecouplamQ
)
2694 atom
->typeB
= atomtype_decouple
;
2699 void convert_moltype_couple(t_molinfo
*mol
, int atomtype_decouple
, real fudgeQQ
,
2700 int couple_lam0
, int couple_lam1
,
2701 bool bCoupleIntra
, int nb_funct
, t_params
*nbp
,
2704 convert_pairs_to_pairsQ(mol
->plist
, fudgeQQ
, &mol
->atoms
);
2707 generate_LJCpairsNB(mol
, nb_funct
, nbp
, wi
);
2708 set_excl_all(&mol
->excls
);
2710 decouple_atoms(&mol
->atoms
, atomtype_decouple
, couple_lam0
, couple_lam1
,