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) 2011,2014,2015,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.
37 /* This file is completely threadsafe - keep it that way! */
40 #include "hackblock.h"
44 #include "gromacs/gmxpreprocess/notset.h"
45 #include "gromacs/math/vec.h"
46 #include "gromacs/mdtypes/md_enums.h"
47 #include "gromacs/topology/atoms.h"
48 #include "gromacs/topology/symtab.h"
49 #include "gromacs/utility/cstringutil.h"
50 #include "gromacs/utility/exceptions.h"
51 #include "gromacs/utility/fatalerror.h"
52 #include "gromacs/utility/gmxassert.h"
53 #include "gromacs/utility/smalloc.h"
55 /* these MUST correspond to the enum in hackblock.h */
56 const char *btsNames
[ebtsNR
] = { "bonds", "angles", "dihedrals", "impropers", "exclusions", "cmap" };
57 const int btsNiatoms
[ebtsNR
] = { 2, 3, 4, 4, 2, 5 };
59 MoleculePatchType
MoleculePatch::type() const
61 if (oname
.empty() && !nname
.empty())
63 return MoleculePatchType::Add
;
65 else if (!oname
.empty() && nname
.empty())
67 return MoleculePatchType::Delete
;
69 else if (!oname
.empty() && !nname
.empty())
71 return MoleculePatchType::Replace
;
75 GMX_THROW(gmx::InvalidInputError("Unknown type of atom modification"));
79 void clearModificationBlock(MoleculePatchDatabase
*globalPatches
)
81 globalPatches
->name
.clear();
82 globalPatches
->hack
.clear();
83 for (int i
= 0; i
< ebtsNR
; i
++)
85 globalPatches
->rb
[i
].b
.clear();
89 #define safe_strdup(str) (((str) != NULL) ? gmx_strdup(str) : NULL)
91 static bool contains_char(const BondedInteraction
&s
, char c
)
95 for (int i
= 0; i
< MAXATOMLIST
; i
++)
97 if (!s
.a
[i
].empty() && s
.a
[i
][0] == c
)
107 rbonded_find_atoms_in_list(const BondedInteraction
&b
, gmx::ArrayRef
<const BondedInteraction
> blist
, int natoms
)
111 for (auto it
= blist
.begin(); (it
!= blist
.end()) && ( foundPos
< 0); it
++)
113 bool atomsMatch
= true;
114 for (int k
= 0; k
< natoms
&& atomsMatch
; k
++)
116 atomsMatch
= atomsMatch
&& (b
.a
[k
] == it
->a
[k
]);
118 /* Try reverse if forward match did not work */
122 for (int k
= 0; k
< natoms
&& atomsMatch
; k
++)
124 atomsMatch
= atomsMatch
&& (b
.a
[k
] == it
->a
[natoms
-1-k
]);
129 foundPos
= std::distance(blist
.begin(), it
);
130 /* If all the atoms AND all the parameters match, it is likely that
131 * the user made a copy-and-paste mistake (since it would be much cheaper
132 * to just bump the force constant 2x if you really want it twice).
133 * Since we only have the unparsed string here we can only detect
134 * EXACT matches (including identical whitespace).
138 gmx_warning("Duplicate line found in or between hackblock and rtp entries");
145 bool mergeBondedInteractionList(gmx::ArrayRef
<const BondedInteractionList
> s
,
146 gmx::ArrayRef
<BondedInteractionList
> d
,
150 bool bBondsRemoved
= false;
151 for (int i
= 0; i
< ebtsNR
; i
++)
155 /* Record how many bonds we have in the destination when we start.
157 * If an entry is present in the hackblock (destination), we will
158 * not add the one from the main rtp, since the point is for hackblocks
159 * to overwrite it. However, if there is no hackblock entry we do
160 * allow multiple main rtp entries since some forcefield insist on that.
162 * We accomplish this by checking the position we find an entry in,
163 * rather than merely checking whether it exists at all.
164 * If that index is larger than the original (hackblock) destination
165 * size, it was added from the main rtp, and then we will allow more
166 * such entries. In contrast, if the entry found has a lower index
167 * it is a hackblock entry meant to override the main rtp, and then
168 * we don't add the main rtp one.
170 int nbHackblockStart
= d
[i
].b
.size();
172 for (const auto &b
: s
[i
].b
)
174 /* Check if this bonded string already exists before adding.
175 * We are merging from the main RTP to the hackblocks, so this
176 * will mean the hackblocks overwrite the man RTP, as intended.
178 int index
= rbonded_find_atoms_in_list(b
, d
[i
].b
, btsNiatoms
[i
]);
179 /* - If we did not find this interaction at all, the index will be -1,
180 * and then we should definitely add it to the merged hackblock and rtp.
182 * Alternatively, if it was found, index will be >=0.
183 * - In case this index is lower than the original number of entries,
184 * it is already present as a *hackblock* entry, and those should
185 * always override whatever we have listed in the RTP. Thus, we
186 * should just keep that one and not add anything from the RTP.
187 * - Finally, if it was found, but with an index higher than
188 * the original number of entries, it comes from the RTP rather
189 * than hackblock, and then we must have added it ourselves
190 * in a previous iteration. In that case it is a matter of
191 * several entries for the same sequence of atoms, and we allow
192 * that in the RTP. In this case we should simply copy all of
193 * them, including this one.
195 if (index
< 0 || index
>= nbHackblockStart
)
197 if (!(bMin
&& contains_char(b
, '-'))
198 && !(bPlus
&& contains_char(b
, '+')))
202 else if (i
== ebtsBONDS
)
204 bBondsRemoved
= true;
209 /* This is the common case where a hackblock entry simply
210 * overrides the RTP, so we cannot warn here.
216 return bBondsRemoved
;
219 void copyPreprocessResidues(const PreprocessResidue
&s
, PreprocessResidue
*d
, t_symtab
*symtab
)
223 for (const auto &a
: s
.atom
)
225 d
->atom
.push_back(a
);
228 for (const auto &a
: s
.atomname
)
230 d
->atomname
.push_back(put_symtab(symtab
, *a
));
233 for (const auto &c
: s
.cgnr
)
235 d
->cgnr
.push_back(c
);
237 for (int i
= 0; i
< ebtsNR
; i
++)
239 d
->rb
[i
].type
= s
.rb
[i
].type
;
242 mergeBondedInteractionList(s
.rb
, d
->rb
, FALSE
, FALSE
);
245 void mergeAtomModifications(const MoleculePatchDatabase
&s
, MoleculePatchDatabase
*d
)
247 for (const auto &h
: s
.hack
)
249 d
->hack
.push_back(h
);
253 void mergeAtomAndBondModifications(const MoleculePatchDatabase
&s
, MoleculePatchDatabase
*d
)
255 mergeAtomModifications(s
, d
);
256 mergeBondedInteractionList(s
.rb
, d
->rb
, FALSE
, FALSE
);
259 void copyModificationBlocks(const MoleculePatchDatabase
&s
, MoleculePatchDatabase
*d
)
264 for (int i
= 0; i
< ebtsNR
; i
++)
268 mergeAtomAndBondModifications(s
, d
);