You are on page 1of 8

pubs.acs.

org/jcim Article

DLPGEN: Preparing Molecular Dynamics Simulations with Support


for Polarizable Force Fields
Carlos E. S. Bernardes*

Cite This: J. Chem. Inf. Model. 2022, 62, 1471−1478 Read Online

ACCESS Metrics & More Article Recommendations


See https://pubs.acs.org/sharingguidelines for options on how to legitimately share published articles.

ABSTRACT: Preparing input files for molecular dynamics (MD)


Downloaded via UNIV FED DE OURO PRETO on August 9, 2023 at 17:23:18 (UTC).

simulations can be a tedious task, particularly if different MD


programs need to be used. Most simulation packages are
accompanied by applications that handle this task, and, in some
cases, software to perform interconversion between MD programs
can be found. However, the conversion between different types of
files is not always foolproof or the force field may not be fully
supported, as quite often observed with polarization models. This
work describes the program DLPGEN, which produces input files
for the MD programs GROMACS, CHARMM, DL_POLY, and
LAMMPS. The program can prepare polarizable force fields using a self-consistent field approach or with a dual thermostat-extended
Lagrangian model. For GROMACS, a new polarization scheme suitable for the simulation of molecules containing more than one
virtual particle is described. Results obtained for ethanol in the liquid state revealed that the system configurational energy, liquid
density, and self-diffusion coefficient obtained with GROMACS are in good agreement with the data found with LAMMPS and
CHARMM. In the case of DL_POLY, a problem with the Shells temperature control was found, suggesting that this program may
not be suitable for the simulation of molecules containing multiple Drude particles.

1. INTRODUCTION large time scales.12 Consequently, because it may be extremely


One of the key steps to run molecular dynamics (MD) difficult for a user (particularly one at the beginners level) to
simulations involves the production of input files that are fed learn the tricks of the trade of new software, applications that can
into the main simulation packages. In general, this requires a facilitate this transition are in demand. Programs like
cross-check between different types of data, like molecular FFTOOL,13 ForConX,14 CHAMBER,15 and MDWiZ16 have
structure (e.g., atomic coordinates) and force field para- been developed over the years, aiming at the creation and
metrizations, to generate a set of formatted files that are interconversion of input files between different platforms.
readable by the MD software.1,2 Unfortunately, different coding However, using these applications, it may be difficult to obtain
procedures are used by different MD programs, so that, except input files from scratch, some are not bidirectional, and 100%
for a few cases, no transferability of input files exists. transferability is not always ensured during the conversion
Most simulation programs are accompanied by applications process.
that handle the task of preparing the input files. However, The program DLPGEN, which dates from 2015,4 was initially
because each MD application has its abilities and limitations, a developed to produce input files for DL_POLY using force fields
user can find itself in the need to use more than one program to based on the all-atom optimized potentials for liquid simulations
tackle different problems. For example, (i) DL_POLY is, most (OPLS-AA) and polarization using a scheme similar to the
likely, one of the most robust programs for the simulations of classical Drude oscillator method.17 A later upgrade enabled the
crystal structures;3−6 (ii) LAMMPS is one of the more versatile production of GROMACS input files. However, because of the
MD software, with the support of a large variety of force fields poor documentation on how to implement polarization in this
and features;7,8 (iii) for the use of polarizable models, because of program (particularly for molecules with several polarized
the extensive developments over the last decades, CHARMM is,
most likely, one of the most robust programs to run simulations
using the classical Drude oscillator model;9−11 (iv) although Received: December 18, 2021
rather limited in terms of supported force fields and simulation Published: March 3, 2022
options (e.g., a limited number of barostats, thermostats, and
interaction potential functions are available), GROMACS is,
probably, one of the fastest free MD programs, making it ideal to
perform the simulation of extremely large systems or to tackle

© 2022 American Chemical Society https://doi.org/10.1021/acs.jcim.1c01431


1471 J. Chem. Inf. Model. 2022, 62, 1471−1478
Journal of Chemical Information and Modeling pubs.acs.org/jcim Article

Figure 1. Schematic representation of the program DLPGEN.

atoms), this option was left aside. From these initial steps, it and crystal unit cell dimensions. The GEN file contains the
became clear that DLPGEN had the potential to become a atomic coordinates of the atoms for a given molecule and
capable platform to prepare input files from scratch for a larger additional instructions necessary to set the force field. These
variety of MD simulation programs. In addition, if the produced include (i) virtual particles details; (ii) definition of rigid units;
input files follow a similar structure, a significant decrease in the (iii) polarization details; and (iv) symmetry operations to build
“activation energy” for the use of different MD software could be crystal structures. Finally, the LIBrary file contains the force field
achieved. Thus, this work describes the most recent develop- data in the form of the potential function, Ucfg:
ments to this program, which include (i) support for DL_POLY, bonds angles dihedral
GROMACS, LAMMPS, and CHARMM; (ii) support of Ucfg = ∑ Ubonds + ∑ Uangles + ∑ Udihedral
polarizable models for all MD packages (for this, a “new” ij ijk ijkl
implementation scheme for the treatment of polarization in
GROMACS is described); (iii) ready-to-go input files, with + ∑ ∑ Ucoul + ∑ ∑ Uvdw
similar structures independent of the destination software (as far i j>i i j>i (1)
as it is possible), from which the user can easily set new
In the previous equation, Ubonds and Uangle represent the
simulations and explore the features of the different MD
potential functions that describe the motion of the bonds and
programs.
angles of a molecule, respectively, as harmonic oscillators:
This study has the following structure. Initially, a brief
overview of the DLPGEN program is given. Next, a small review k r, ij
of polarizable force fields is presented, with a discussion of the Ubonds = (rij − ro, ij)2
2 (2)
corresponding implementation for each MD program. Finally, a
comparison of simulation results obtained using the different kθ , ijk
programs is provided. Uangles = (θijk − θo, ijk)2
2 (3)

2. DLPGEN PROGRAM where rij and ro,ij are the distance and the equilibrium distance
between atoms i and j, respectively; θijk and θo,ijk are the angle
One of the difficulties in the development of an application that and equilibrium angle between atoms i−j−k. In turn, Udihedral
interconverts input files is to ensure the compatibility between represents the variation of the potential energy of a dihedral as a
the potential functions that can be used with each MD program. function of the angle φijkl defined between atoms i−j−k−l. In
Some of these problems, dealing with, for example, energy and this case, it is possible to use one of the following functions for
distance units, can easily be handled. However, not all force each dihedral:
fields models and algorithms are supported by a given software. 4
Good examples are the implementations of polarization models, Vn , ijkl
Udihedral = ∑ [1 + ( −1)(n − 1)cos(nφijkl)]
the ability to recognize virtual particles, or the supported 2 (4)
n=1
barostats and thermostats. Thus, a program that can create input
files for multiple MD packages must be able to automatically Udihedral = K ijkl[1 + cos(mφijkl − f )] (5)
account for these issues.
A schematic representation of the DLPGEN program is given where Vn,ijkl are Fourier constants, Kijkl is the dihedral coefficient,
in Figure 1. The program requires three types of files to run: a m is a non-negative integer coefficient that sets the number of
program control file (PCF), a GENesis file, and a LIBrary file. nodes of the cosine function, and f is the dihedral phase. Eq 4 is
The PCF contains information about the system to be also used to define the improper dihedrals, by setting V1 = V3 =
simulated, as the molecules to be used, simulation box size, V4 = 0 and V2 > 0.
1472 https://doi.org/10.1021/acs.jcim.1c01431
J. Chem. Inf. Model. 2022, 62, 1471−1478
Journal of Chemical Information and Modeling pubs.acs.org/jcim Article

The Coulomb, Ucoul, and van der Waals, Uvdw, functions in eq simulation conditions to be used during a simulation (e.g.,
1 are based on the classical electrostatic and 12-6 Lennard-Jones number of steps, timestep, cutoffs, temperature, and pressure).
relations: The initial simulation box can be prepared using two
qiqj procedures: (i) by stacking small virtual boxes containing the
Ucoul = molecules or (ii) using the program PACKMOL24 (which

ÅÄÅ ÑÉ
4πεorij (6) allows for the random distribution of the molecules inside a

ÅÅij σ yz12 ij σ yz6ÑÑÑ


simulation box). For the first procedure, several small boxes
ÅÅjj ij zz Ñ
= 4εijÅÅÅjj zz − jjjj zzzz ÑÑÑÑ
(e.g., 10 Å × 10 Å × 10 Å), each one containing one molecule,
j
ÅÅ rij z j r Ñ z
ÅÅÇk { k ij { ÑÑÖÑ
ij
Uvdw are staked to form an expanded cubic simulation box.
(7) Alternatively, the unit cell of a crystal structure can be used as
a starting point, and by applying the symmetry operations of a
where εo is the vacuum permittivity, qi and qj are the atomic given space group to the corresponding asymmetric unit, a
point charges of atoms i and j, respectively, and σij and εij are the perfect crystal structure for a given compound can be prepared.
Lennard-Jones parameters. The use of PACKMOL is integrated into DLPGEN, so only the
By default, the program follows the OPLS-AA18 force field simulation box dimension or a target system density needs to be
scheme, namely, (i) within the same molecule, the electrostatic provided by a user (for this, PACKMOL should have been
and van der Waals interactions between atoms separated by previously installed in the computer).
three bonds (1−4 interactions) are scaled by a 0.5 factor Full details on how to install, prepare the input files, and run
(different scaling factors can be used), (ii) the interaction DLPGEN can be found in the manual that accompanies the
between atoms connected by one or two bonds are ignored, and program or downloaded from https://bit.ly/3rIaSXu. Addition-
(iii) all bonds with hydrogen atoms are constrained. The LJ ally, a tutorial with a step-by-step description of how to use the
parameters between different types of atoms can be computed as program is available on the YouTube channel DLPGEN
geometrical means, applying Lorentz−Berthelot mixing rules
(https://bit.ly/3oLOESC).
(sigmas computed as arithmetic means and epsilons as
geometric means), using custom LJ parameters for crossed
interactions, or the n−m potential function introduced by Clarke 3. POLARIZATION MODELS

ÄÅ mÉ
ij r yz ÑÑÑÑ
and Smith:19
Å
The use of polarizable force fields has received significant
Eo ÅÅÅ ijj ro yzz
ÅÅmjj zz − njjj o zzz ÑÑÑ
attention in recent years as it potentially enables a more accurate

n − m ÅÅÅ jj rij zz jj r zz ÑÑ
n

ÅÇ k { k ij { ÑÑÖ
Uij = description of the computed physical properties of substances
when compared with classical simulations. For example, (i)
(8)
when employed in the study of ionic liquids, it allows for a better
where n and m are the repulsive and attractive coefficients, agreement between theoretical and experimental dynamic
respectively, and Eo and ro are the energy and distance properties data (e.g., diffusion data),25−27 (ii) when used to
parameters, respectively. By using the set of potential functions investigate materials in the solid state, it allows for a better
described above, DLPGEN can, therefore, be used to set agreement between experimental and computed energetic and
simulations using force fields like OPLS-AA, CL&P, AMBER, structural results of organic compound polymorphs,4 and (iii)
and CHARMM.18,20−23 allows for a better description of carbon-based materials, like
When the program runs, the contents of the files are analyzed, graphene sheets and carbon nanotubes, with other substances.28
and the connectivity (bonds) between all atoms included in each It should be mentioned, however, that MD simulations using
GEN file is determined. For this, the program compares the polarizable models come with a penalty in computation time
distance between every two atoms against typical values for a and, in some cases, for example, double counting of induction
given type of bond. The current version of the program contains and dispersion interactions may make the agreement of
a database with connectivity criteria for several atom pairs, simulation results with the experiment difficult.27,29 Detailed
suitable to handle most of the common bonds observed in information about the different approaches to include polar-
organic compounds. Still, if a distance criterion to establish if ization in MD simulations can be found elsewhere.17 Thus, in
two atoms are bonded is not in the list, the program requests the this work, only a brief overview of the classical Drude oscillator
user for a reference value. In principle, the program can be used model (CDO) and the implementations used by DLPGEN is
with molecules containing an unlimited number of atoms, so discussed.
that any molecule (organic or inorganic) can be handled by In the CDO model (Figure 2a), polarization is introduced by
DLPGEN. After this process, the program determines all angles, placing virtual charged particles, β, (Drude or Shells) that move
dihedrals, and improper dihedrals for the molecule. The around the atom Core, i. This configuration can be envisioned as
improper dihedrals are considered if (i) the central atom is a an electron cloud that reacts with the surrounding electric field.
carbon atom and is bonded to any three atoms (sp 2 The particle is connected by a spring to the atom nucleus,
hybridization); (ii) the central atom is a nitrogen (N) bonded allowing for the development of induced dipoles. The charge in
to three atoms (X) and if the angle defined by the improper the Drude particles, qβD, is computed as follows:
dihedral X−N−X−X is close to 0° or 180°.
The output files for a given MD package consist of at least
three files (see details below): (i) the first one contains the qβD = 4πεok Dα (9)
topological details of the different molecular types in the system.
This file is compiled by linking the computed connectivity where α is the atom polarizability, and kD is the force constant of
information with the parametrization included in the LIB file; the spring connecting the Drude particles to the atom Core,
(ii) the second file contains the initial positions of the atoms in assuming a harmonic oscillator with an equilibrium distance of
the simulation box; and (iii) the last one contains initial default zero:
1473 https://doi.org/10.1021/acs.jcim.1c01431
J. Chem. Inf. Model. 2022, 62, 1471−1478
Journal of Chemical Information and Modeling pubs.acs.org/jcim Article

(αe = −1.87 Å3) and anions (αe = +1.87 Å3) can also be included
in the force field, by evenly distributing this excess polarizability
throughout all atoms.34
When two adjacent Drude/Shell particles (in the same or
different molecules) are close to each other, a strong interaction
can develop. This may lead to an excessive energy variation,
causing unstable simulations and/or excessive correlation
between induced dipoles. To avoid this, a Thole screening

ÄÅ ÉÑ
function is employed:35,36
Å ij y ÑÑ
qiq j ÅÅÅÅ j z
zzz·e−a·rij /(αiαj) ÑÑÑ
Ñ
ÅÅ1 − jjj1 + z ÑÑ
rij ÅÅÅ jj 2(αiαj) zz
a · r
ÑÑ
ij 1/6

ÅÇ k { ÑÖ
Figure 2. Schematic representation of the (a) classical Drude oscillator Sk(rij) = 1/6
model implemented in DLPGEN for the MD packages CHARMM, (12)
LAMMPS, and DL_POLY, and (b) GROMACS.
where qi and qj are the charges of the Drude/Shell/Core
D
k 2 particles that compose the induced dipoles, αi and αj are the
U= ·riβ
2 (10) polarizabilities of the atoms, and a is the Thole damping
parameter. In the simulation of organic-based substances, the
where riβ is the distance between the Drude and the atom Core. latter constant is normally assumed to be equal to 2.6.36 When
In general, two procedures are followed to set qβD and kD:17,25 (i) Thole screening functions are not available in the MD package in
the charges of the Drude particles are predefined, for example, use, as an alternative, it has been proposed the application of
−1 e, and kD determined using eq 9; (ii) kD is fixed to a constant exclusion list between the induced dipoles separated by one or
value, typically between 4184 and 8368 kJ mol−1, and the two bonds and using scaling between atoms separated by three
corresponding qβD value computed from eq 9. Although both bonds. This approach mimics the procedures used to handle
approaches lead to equivalent results, the latter one is normally intramolecular Coulomb and LJ interactions between bonded
preferred, as it allows for better control over the timestep used in atoms. Although this does not scale the intermolecular
the calculations. Finally, once qβD has been defined/determined, interaction, it was found to be suitable, for example, when
the charge of the atom Core, qiC, is computed as follows: simulating ionic liquids using the CL&P force field.37,38
qi C = q FF − qβ D (11) 4. FORCE FIELD IMPLEMENTATIONS
where qFF is the charge of the atom type in the reference force This section gives a brief overview of the output files produced
field. with DLPGEN, with emphasis on the polarization methods
The inclusion of virtual particles in the model leads to a implemented for the different MD programs. By default, ready-
problem regarding the description of their dynamic motions. to-go files are generated, allowing for the simulation of a
Two main approaches were developed to address this issue: (i) molecular system under the NPT ensemble approximation, at
the Shells do not have mass, so after moving all atoms in the 298.15 K and a pressure of 1 bar. If the simulation to be run
simulation box, the position of each particle is recomputed to corresponds to a crystalline material, an NσT ensemble is
minimize the energy/forces. For this, a self-consistency field configured instead, by setting an anisotropic barostat. With the
(SCF) approach is used to relax the Shells while keeping the exception of GROMACS, which uses a Parrinello−Rahman
atom Cores at fixed positions, in a procedure that falls in analogy barostat, a Nosé−Hoover barostat and a thermostat are defined
to the Born−Oppenheimer approximation;30,31 (ii) a small mass for the simulations. Independent of the program to be used, no
(typically mD = 0.4 amu) is transferred from the atom Core to initial velocities for the particles are computed, a cutoff of 1.5 nm
the Drude, enabling the inclusion of these particles during the with Ewald corrections is configured, and a timestep of 1 or 2 fs
integration of Newton’s equations of motion.25,32 The latter is set.
approach has the advantage of being faster because SCF 4.1. CHARMM. For the simulations with CHARMM, four
calculations are time-consuming and need to be run in every files named “config.crd,” “parameters.prm,” “topology.rtf,” and
simulation step. However, because the mass of the Drudes is “input_chrm.inp,” are produced, which contain the initial
small, the timestep used in the simulations needs to be small. system configuration, the force field details, the molecular
This effect can be minored using the extended Lagrangian information, and the simulation setup conditions, respectively.
approach developed by Lamoureux and Roux.33 By this way, a The latter file is written in a scripting language, which makes
dual thermostat is used in the simulation runs: the first one keeps CHARMM extremely versatile. To simplify the setting up of the
the atoms at the desired temperature and the second maintains simulations, the first lines of this file contain a “nonstandard”
the Drudes at a very low temperature (e.g., ≤1 K). The section, where all main simulation variables can be easily
combined use of mD = 0.4 amu and a fixed spring constant force changed (e.g., temperature, pressure, timestep, cutoff, and
of kD ≥ 4184 kJ mol−1 often allows for the use of 1 fs simulation experiment number).
timestep. Arguably, from all programs supported by DLPGEN,
An additional problem that can be found in the extended CHARMM is a reference for the implementation of the classical
Lagrangian approach, which is not an issue for the SCF method, Drude oscillator model. The setting up of polarization follows
is the polarization of light atoms (e.g., hydrogens). Thus, quite strongly the CDO model described in the previous section.
often, these atoms are not polarized in the force field, and the 4.2. LAMMPS. For the simulations with LAMMPS, three
corresponding polarizability is added to that of the heavy atom files are produced, named “data.lmp,” “pair.lmp,” and “in.lmp.”
they are attached to.25,26 In addition, if the molecules to be The first one contains the force field and initial configuration
polarized are ions, corrections to the polarizability of the cations data and the second the van der Waals interaction parameters.
1474 https://doi.org/10.1021/acs.jcim.1c01431
J. Chem. Inf. Model. 2022, 62, 1471−1478
Journal of Chemical Information and Modeling pubs.acs.org/jcim Article

Like CHARMM, the file “in.lmp” uses a scripting language avoiding the catastrophic events described above while ensuring
approach to set up the experiments. Thus, the first lines of this the correct 1−4 Coulomb interactions between the atom Cores
file also contain a list of variables that allow for an easy (the only electrostatic interaction considered between atoms
modification of the simulation conditions. separated by three bonds). Thus, the dihedral potentials are, in
The classical Drude oscillator model was recently developed this case, modeled exactly with the same potential functions of
and included in the stable releases of LAMMPS by Padua and the original force field (e.g., scaling the 1−4 interactions to 0.5,
Dequidt.39 The authors developed a Python tool named as in the case of OPLS-AA and CL&P).18,21
“polarizer,” which can modify previously existent input files to 4.4. DL_POLY. For simulations with DL_POLY, three files
include polarization. Still, using this program, several simulation named “CONFIG,” “FIELD,” and “CONTROL” are produced,
details (e.g., thermostat configurations) need to be manually which include the initial system configuration, the force field and
added to run the simulations. The code implemented in molecular information, and the simulation conditions, respec-
DLPGEN produces ready-to-go files that strongly follow the tively. This MD program allows running simulations using both
classical Drude oscillator method described in Section 3. the extended Lagrangian and SCF approaches. In the most
4.3. GROMACS. For the simulations with GROMACS, three recent version of DL_POLY, it is also possible to use Thole
files are produced, named “CONFIG.gro,” “topology.top,” and screening functions in the simulations with polarizable force
“NPT.mdp.” These files contain, respectively, the initial system fields. Still, after several attempts and messages exchanged with
configuration, the force field and molecular information, and the the developer of this module, no stable implementation of this
conditions for the MD run. feature was obtained for molecules containing more than one
In this work, it was found that the available information for the Drude/Shell particle (this will be pursued in future versions of
implementation of the Drude oscillator model was extremely DLPGEN). The final implementation follows the CDO model
scattered, particularly, if molecules containing more than one described in Section 3 using an exclusion list to ignore
Drude particle were considered. In 2015, Mackerel’s team40 interactions between atoms separated by one or two bonds
released a GROMACS version supporting the classical Drude and with the interactions (Core−Core; Core−Drude; Drude−
oscillator model. As an example, the authors demonstrated how Drude) separated by three bonds scaled by a factor of 0.5.
to implement this force field for water. However, to the best of
my knowledge, this version of the program was never tested with 5. SIMULATION RESULTS
molecules containing multiple Drude particles, and the In this section, a direct comparison between MD simulation
implementation was never included in subsequent official results obtained using different software packages and input files
versions of GROMACS. Thus, in this work, an attempt to directly produced with DLPGEN is presented. Particular
implement a polarizable model suitable for use in the most attention is given to the results found using GROMACS with
recent versions of the program was made. a polarizable force field because of the novelty of the approach
As referred above, one of the key points of the extended described in this work. The tests consisted of the comparison of
Lagrangian approach is the use of two thermostats, one for the simulation results for ethanol.
Core atoms and the other for the Drude particles. GROMACS As a starting point, a simulation box with 600 ethanol
has built-in capabilities to set several independent thermostats; molecules was initially prepared and equilibrated using
however, to work properly, the temperature difference between GROMACS and considering the OPLS-AA force field.18 For
the two thermostats should be small (ca. <100 K). As a result, it this, the following procedure was followed: (i) 2 ns MD run at a
is not possible to use this approach if, for example, the Core temperature of T = 398.15 K and pressure p = 100 bar; (ii) 2 ns
particle temperature is set to 298 K and Drudes at 1 K. This was, simulation at T = 298.15 K and p = 100 bar; (iii) 3 runs at T =
in fact, one of the developments made in Mackerel’s work.40 298.15 K and p = 1 bar, with 5 ns each. The final simulation box
To circumvent the previous issues, massless virtual Shell (which presented a constant density and configurational energy
particles were set, and the built-in force minimization algorithm in the last MD run) was then used as the starting point to prepare
was used to compute the positions of each Shell at every step. the configurational files for each probed MD program. Before
This implementation revealed, however, that when a molecule each production stage, an additional 1 ns run was performed
contains atoms separated by three bonds, a catastrophic event using each MD software. This aimed at the elimination of any
would rapidly occur. For example, in the case of the ethanol eventual problem rising from the fact that the main equilibration
molecule (Figure 2), the hydrogen atom of the hydroxyl group procedure has been made with GROMACS.
can strongly interact with the Shell particle in the adjacent The following settings were used in the simulations with the
methyl group. It was also found that the use of Thole screening polarized force field: (i) the atomic polarizabilities previously
functions or hyperbolic spring constants, in this case, did not reported were selected:34 α(C) = 1.081 Å3, α(H) = 0.389 Å3,
avoid this process. This suggested that the latter models/ α(O) = 0.354 Å3; (ii) kD = 4184 kJ·mol−1; (iii) mD = 0.4 amu;
corrections are not appropriate to avoid catastrophic events (iv) only non-hydrogen atoms were polarized, and the
when massless Shells and force minimization methods are used. polarizability of the hydrogens was added to that of the heaviest
This led to the following implementation (Figure 2b): (i) element they were attached; (v) except for DL_POLY
each heavy atom has attached a massless Shell particle with calculation, to which 1−4 exclusion was set between induced
charge qβD; (ii) additionally, to each atom Core, a second virtual dipoles, Thole screening functions were employed with a
particle located at the atom nuclei with charge −qβD was also damping parameter of a = 2.6 attributed to each atom.
added (this particle does not move relative to the atom Core); Each production stage consisted of 20 and 10 ns runs for the
(iii) the charge of the atom Core is set to qFF; (iv) all interactions nonpolarized and polarized simulations, respectively. A temper-
between Shells and between the pair atom Core/virtual particles ature of 298.15 K and a pressure of 1 bar were used by employing
for atoms separated by 1 to 3 bonds were added to the a Nosé−Hoover thermostat and barostat. In the case of the
interaction exclusion list; (v) Thole screening functions were simulations with GROMACS, as mentioned above, the latter
included in the model. The implementation of step iv allows for barostat is not available, so a Parrinello−Rahman was used
1475 https://doi.org/10.1021/acs.jcim.1c01431
J. Chem. Inf. Model. 2022, 62, 1471−1478
Journal of Chemical Information and Modeling pubs.acs.org/jcim Article

instead. A timestep of 2 fs was selected for the simulations with force field for GROMACS described in this study leads to similar
the nonpolarized force field, while for the polarized runs, a 1 fs results to LAMMPS and CHARMM, which can, in this case, be
was used with GROMACS, CHARMM, and LAMMPS, and 0.5 used as reference data. This suggests that despite the significant
fs with DL_POLY. differences in the model’s implementations, they lead to similar
The simulation results are shown in Table 1. The errors results.
ascribed to the computed values correspond to twice the The data obtained with DL_POLY using the polarizable force
field exhibit the largest deviations to experiment. A close
Table 1. MD Simulation Results for Ethanol at 298.15 K, inspection of the simulation results revealed several issues that
Obtained with DL_POLY, CHARMM, GROMACS, and are worth mentioning. As referred to in Section 3, the use of the
LAMMPS, Using Polarized and Nonpolarized Versions of the Drude/Shell model implies the employment of two thermostats:
OPLS-AA Force Field. The Numbers in Parenthesis one for the Drude particles (set to T = 1 K) and the other for the
Represent the Error Relative to the Experimental Valuesa atom Cores (in this case, 298.15 K). However, as shown in
Figure 3, a constant drift in the Shell particle temperature is
DL_POLY CHARMM GROMACS LAMMPS
nonpolarized
ρ/g cm−3 0.793 ± 0.012 0.782 ± 0.011 0.792 ± 0.793 ±
(1%) (−0.4%) 0.013 0.013
(0.9%) (1.0%)
D/10−9 m2 1.36 ± 0.04 1.41 ± 0.09 1.22 ± 0.14 1.35 ± 0.16
s−1
Uom, cfg(l)/ −16.13 ± −15.49 ± 0.43 −17.38 ± −16.09 ±
kJ mol−1 0.83 0.92 0.70
polarized
ρ/g cm−3 0.888 ± 0.010 0.835 ± 0.004 0.855 ± 0.855 ±
(13.1%) (6.4%) 0.006 0.006
(8.9%) (8.9%)
D/10−9 m2 0.038 ± 0.007 0.426 ± 0.006 0.168 ± 0.243 ±
s−1 0.013 0.043
Uom, cfg(l)/ −36.93 ± 1.5 −27.19 ± 0.39 −29.85 ± −30.26 ±
kJ mol−1 0.85 0.69
a
Experimental reference values at 298.15 K: ρ = 0.785 g cm−3, D = 1.0
× 10−9 m2 s−1.41,42

standard deviation errors (95% confidence level). In general, the


data in Table 1 reveal that independent of the program used, the
values obtained for ethanol using the OPLS-AA force field agree
well with the experiment: (i) the densities show absolute
deviations ≤1% and within the errors of the determinations; (ii)
the self-diffusion coefficient, D, computed from the mean
squared displacement of the molecules in the trajectory, 1.2 < D/
10−9 m2 s−1 < 1.4, are in good agreement with the corresponding
experimental result, D = 1.0 × 10−9 m2 s−1.41,42 The observed
differences between the results found with the four programs are Figure 3. Temperature variation of the Shell, TShell, and Core atoms,
TCore, as a function of the simulation time, obtained using DL_POLY.
most likely related to differences in the computation algorithms
(particularly in the case of GROMACS, where a different
barostat was used), a topic that is outside the scope of this study. noticed, which leads to a change in the different energetic terms
The inclusion of polarization in the force field of ethanol during the simulation (e.g., the Coulomb interaction energy
during the simulations leads to a systematic deviation of the decreased ∼5 kJ mol−1 in a 2 ns period). This suggests energy
results relative to the experiment, independent of the MD transfers between the Drude particles and the atom Cores.
program. In all cases, an increase in density is observed, with Because the settings of the Shells thermostat in DL_POLY
errors ranging from 6 to 13%. One of the largest discrepancies in cannot be controlled by the user, it is impossible to attempt any
the computed results is observed for the self-diffusion coefficient tuning of the temperature control of these particles. To confirm
(0.14 < D/10−9 m2 s−1 < 0.43, excluding the results for that the problem was not related to an eventual issue in the force
DL_POLY, which are discussed in detail below), which is one field implementation, a single point energy calculation was made
order of magnitude smaller than the experimental value. The using LAMMPS and DL_POLY for the same conformation. The
discussion of the underlying reasons for the discrepancies found obtained results were essentially the same for each contribution
between these results and experiment is difficult to assess and is (e.g., Ubonds, Uangle, and Udihedral), except for the total Coulomb
outside the scope of this study. Still, recent studies have energy term, to which a difference of 15 kJ mol−1 was found
highlighted the need for correcting the double counting of using the two programs (Ucoul(DL_POLY) = −13,475 kJ mol−1;
induction and dispersion interactions by scaling the LJ Ucoul(LAMMPS) = −13,460 kJ mol−1). This difference, which
interactions.27,29 The results shown in Table 1 seem to reinforce corresponds to 0.1% of the total system energy, most likely, is
this claim. related to the use of Thole screening only with LAMMPS. Still, it
Despite the significant differences between the experiment is also difficult to relate this fact to a problem in the thermostat.
and theory when polarizable force fields are used, it is important During this work, this issue was discussed with the DL_POLY
to note that the proposed implementation of the polarizable developers. However, until this moment, it was not possible to
1476 https://doi.org/10.1021/acs.jcim.1c01431
J. Chem. Inf. Model. 2022, 62, 1471−1478
Journal of Chemical Information and Modeling pubs.acs.org/jcim Article

find a solution to the problem. Thus, the use of polarizable force dynamic properties (self-diffusion coefficient) obtained using
fields should be performed with caution using this program and, GROMACS are in good agreement with the data obtained with
in the present case, regarded only as indicative. LAMMPS and CHARMM. This suggests that the proposed
5.1. Calculation Times. A key question when performing an methodology is suitable for the simulation of polarized systems
MD simulation study is the knowledge of the computational using GROMACS without a significant increase in the
performance. Because the DLPGEN can implement the same computational time relative to the remaining programs. In the
force field for different programs in the most equivalent way case of the simulations performed using DL_POLY, a problem
possible, it was found interesting to benchmark the different free related to the thermalization of the Shells particles was noticed.
versions of the supported MD software. These tests were based This suggests that the use of this program with molecules
on the simulation where liquid ethanol was used as a starting containing multiple Drude particles should be performed with
point, and the simulation boxes obtained from the results are caution.
shown in Table 1. The same simulation conditions described
above were used, with production runs of 10,000 steps, a cutoff
of 14 Å, and timesteps of 1 and 2 fs for the simulations with and
■ AUTHOR INFORMATION
Corresponding Author
without polarization, respectively. For the sake of consistency, Carlos E. S. Bernardes − Centro de Química Estrutural,
because DL_POLY and the free version of CHARMM do not Institute of Molecular Sciences, Faculdade de Ciências,
support graphical processing units (GPUs) and have limitations Universidade de Lisboa, Lisboa 1749-016, Portugal;
to the number of central processing units (CPUs) that may be orcid.org/0000-0003-1490-9728; Email: cebernardes@
used, all simulations were performed using up to 8 CPUs. The fc.ul.pt
calculations were made in a PC equipped with an AMD RYZEN
9 5900X CPU, using the program versions DL_POLY 4.09.4, Complete contact information is available at:
CHARMM 44b1 (free), LAMMPS (10 February 2021), and https://pubs.acs.org/10.1021/acs.jcim.1c01431
GROMACS 2021. The obtained results are given in Figure 4
Notes
The author declares no competing financial interest.
The program DLPGEN and the documentation necessary to
reproduce the data in the study are freely available for download
at https://bit.ly/3E8nHx2.

■ ACKNOWLEDGMENTS
This work was supported by Fundaçaõ para a Ciência e a
Tecnologia (FCT), Portugal (projects PTDC/QUI-OUT/
28401/2017, LISBOA-01-0145-FEDER-028401, LA/P/0056/
2020, UIDB/00100/2020, and UIDP/00100/2020). The
author would also like to acknowledge Prof. José N. Canongia
Lopes (Univ. Lisbon), Prof. Agílio A. H. Pádua (ENS de Lyon),
and Prof. Christian Schröder (Univ. Vienna) for the useful
discussions.


Figure 4. Simulation times obtained in this work for the simulation of
liquid ethanol, during 10,000 steps, with polarized (OPLS-POL) and
nonpolarized (OPLS-AA) versions of the OPLS force field,18 using the REFERENCES
MD programs supported by DLPGEN. (1) Allen, M. P.; Tildesley, D. J. Computer Simulation of Liquids;
Oxford University Press: Oxford, 1987.
and reveal that CHARMM and DL_POLY are the slowest of the (2) Jensen, F. Introduction to computational chemistry. 2nd ed.; John
test set (mind, however, that this may change if the CHARMM Wiley & Sons: Chichester, U.K., 2007.
paid version is used). In turn, GROMACS is 6 to 19 times faster (3) Bernardes, C. E. S.; Canongia Lopes, J. N. Modeling Halogen
than the remaining programs, when using the nonpolarizable Bonds in Ionic Liquids: A Force Field for Imidazolium and Halo-
force field. Imidazolium Derivatives. J. Chem. Theory Comput. 2017, 13, 6167−
The inclusion of polarization dramatically increases the 6176.
(4) Bernardes, C. E. S.; Joseph, A. Evaluation of the OPLS-AA Force
computation times. The largest impact is noticed for
Field for the Study of Structural and Energetic Aspects of Molecular
GROMACS, which increases ∼13 times. This is, most likely, Organic Crystals. J. Phys. Chem. A 2015, 119, 3023−3034.
related to the need of using the slow iterative SCF method. Still, (5) Bernardes, C. E. S.; Mochida, T.; Canongia Lopes, J. N. Modeling
its computation time is like that of LAMMPS. the structure and thermodynamics of ferrocenium-based ionic liquids.
Phys. Chem. Chem. Phys. 2015, 17, 10200−10208.
6. CONCLUSIONS (6) Todorov, I. T.; Smith, W.; Trachenko, K.; Dove, M. T.
In this work, the program DLPGEN, which produces input files DL_POLY_3: New Dimensions in Molecular Dynamics Simulations
for the MD programs GROMACS, CHARMM, DL_POLY, and via Massive Parallelism. J. Mater. Chem. 2006, 16, 1911−1918.
LAMMPS, is described. In the case of the latter three programs, (7) Plimpton, S. Fast Parallel Algorithms for Short-Range Molecular-
Dynamics. J. Comput. Phys. 1995, 117, 1−19.
polarization is introduced using the classical Drude oscillator (8) Thompson, A. P.; Aktulga, H. M.; Berger, R.; Bolintineanu, D. S.;
approach. For GROMACS, a new Shell model suitable for the Brown, W. M.; Crozier, P. C.; Veld, P. J.; Kohlmeyer, A.; Moore, S. G.;
simulation of molecules containing more than one virtual Nguyen, T. D.; Shan, R.; Stevens, M.; Tranchida, J.; Trott, C.;
particle was described. The comparison of the results obtained Plimpton, S. J. LAMMPS - A Flexible Simulation Tool for Particle-
for liquid ethanol using the polarizable models revealed that Based Materials Modeling at the Atomic, Meso, and Continuum Scales.
both static (configurational energy and liquid densities) and Comput. Phys. Commun. 2022, 271, No. 108171.

1477 https://doi.org/10.1021/acs.jcim.1c01431
J. Chem. Inf. Model. 2022, 62, 1471−1478
Journal of Chemical Information and Modeling pubs.acs.org/jcim Article

(9) Brooks, B. R.; Brooks, C. L.; Mackerell, A. D.; Nilsson, L.; Petrella, (28) Schyman, P.; Jorgensen, W. L. Exploring Adsorption of Water
R. J.; Roux, B.; Won, Y.; Archontis, G.; Bartels, C.; Boresch, S.; Caflisch, and Ions on Carbon Surfaces Using a Polarizable Force Field. J. Phys.
A.; Caves, L.; Cui, Q.; Dinner, A. R.; Feig, M.; Fischer, S.; Gao, J.; Chem. Lett. 2013, 4, 468−474.
Hodoscek, M.; Im, W.; Kuczera, K.; Lazaridis, T.; Ma, J.; Ovchinnikov, (29) Padua, A. A. H. Resolving Dispersion and Induction
V.; Paci, E.; Pastor, R. W.; Post, C. B.; Pu, J. Z.; Schaefer, M.; Tidor, B.; Components for Polarisable Molecular Simulations of Ionic Liquids.
Venable, R. M.; Woodcock, H. L.; Wu, X.; Yang, W.; York, D. M.; J. Chem. Phys. 2017, 146, 204501.
Karplus, M. CHARMM: The Biomolecular Simulation Program. J. (30) Osullivan, K. F.; Madden, P. A. Light-Scattering by Alkali-Halides
Comput. Chem. 2009, 30, 1545−1614. Melts - a Comparison of Shell-Model and Rigid-Ion Computer-
(10) Patel, S.; Mackerell, A. D.; Brooks, C. L. CHARMM fluctuating Simulation Results. J. Phys.: Condens. Matter 1991, 3, 8751−8756.
charge force field for proteins: II - Protein/solvent properties from (31) Lindan, P. J. D.; Gillan, M. J. Shell-Model Molecular-Dynamics
molecular dynamics simulations using a nonadditive electrostatic Simulation of Superionic Conduction in CaF2. J. Phys.: Condens. Matter
model. J. Comput. Chem. 2004, 25, 1504−1514. 1993, 5, 1019−1030.
(11) Harder, E.; Anisimov, V. M.; Vorobyov, I. V.; Lopes, P. E. M.; (32) Sprik, M. Computer-Simulation of the Dynamics of Induced
Noskov, S. Y.; MacKerell, A. D.; Roux, B. Atomic Level Anisotropy in Polarization Fluctuations in Water. J. Phys. Chem. 1991, 95, 2283−
the Electrostatic Modeling of lone Pairs for a Polarizable Force Field 2291.
Based on the Classical Drude Oscillator. J. Chem. Theory Comput. 2006, (33) Lamoureux, G.; Roux, B. Modeling Induced Polarization with
2, 1587−1597. Classical Drude Oscillators: Theory and Molecular Dynamics
(12) Abraham, M. J.; Murtola, T.; Schulz, R.; Páll, S.; Smith, J. C.; Simulation Algorithm. J. Chem. Phys. 2003, 119, 3025−3039.
Hess, B.; Lindahl, E. GROMACS: High Performance Molecular (34) Bernardes, C. E. S.; Shimizu, K.; Lopes, J. N. C.; Marquetand, P.;
Simulations Through Multi-Level Parallelism from Laptops to Heid, E.; Steinhauser, O.; Schröder, C. Additive Polarizabilities in Ionic
Supercomputers. SoftwareX 2015, 1-2, 19−25. Liquids. Phys. Chem. Chem. Phys. 2016, 18, 1665−1670.
(13) Padua, A. fftool v1.0.0 (v1.0.0). Zenodo, 2015. (35) Thole, B. T. Molecular Polarizabilities Calculated with a
(14) Lesch, V.; Diddens, D.; Bernardes, C. E. S.; Golub, B.; Dequidt, Modified Dipole Interaction. Chem. Phys. 1981, 59, 341−350.
A.; Zeindlhofer, V.; Sega, M.; Schröder, C. ForConX: A Forcefield (36) Noskov, S. Y.; Lamoureux, G.; Roux, B. Molecular Dynamics
Conversion Tool Based on XML. J. Comput. Chem. 2017, 38, 629−638. Study of Hydration in Ethanol-Water Mixtures Using a Polarizable
(15) Crowley, M. F.; Williamson, M. J.; Walker, R. C. CHAMBER: Force Field. J. Phys. Chem. B 2005, 109, 6705−6713.
Comprehensive Support for CHARMM Force Fields Within the (37) Taylor, T.; Schmollngruber, M.; Schröder, C.; Steinhauser, O.
AMBER Software. Int. J. Quantum Chem. 2009, 109, 3767−3772. The Effect of Thole Functions on the Simulation of Ionic Liquids with
(16) Rusu, V. H.; Horta, V. A. C.; Horta, B. A. C.; Lins, R. D.; Baron, R. Point Induced Dipoles at Various Densities. J. Chem. Phys. 2013, 138,
MDWiZ: A platform for the Automated Translation of Molecular 204119.
Dynamics Simulations. J. Mol. Graphics Modell. 2014, 48, 80−86. (38) Schmollngruber, M.; Lesch, V.; Schröder, C.; Heuer, A.;
(17) Bedrov, D.; Piquemal, J. P.; Borodin, O.; MacKerell, A. D., Jr.; Steinhauser, O. Comparing Induced Point-Dipoles and Drude
Roux, B.; Schröder, C. Molecular Dynamics Simulations of Ionic Oscillators. Phys. Chem. Chem. Phys. 2015, 17, 14297−14306.
Liquids and Electrolytes Using Polarizable Force Fields. Chem. Rev. (39) Dequidt, A.; Devemy, J.; Padua, A. A. H. Thermalized Drude
2019, 119, 7940−7995. Oscillators with the LAMMPS Molecular Dynamics Simulator. J. Chem.
(18) Jorgensen, W. L.; Maxwell, D. S.; Tirado-Rives, J. Development Inf. Model. 2016, 56, 260−268.
and Testing of the OPLS All-Atom Force Field on Conformational (40) Lemkul, J. A.; Roux, B.; van der Spoel, D.; MacKerell, A. D.
Energetics and Properties of Organic Liquids. J. Am. Chem. Soc. 1996, Implementation of Extended Lagrangian Dynamics in GROMACS for
118, 11225−11236. Polarizable Simulations Using the Classical Drude Oscillator Model. J.
(19) Clarke, J. H. R.; Smith, W.; Woodcock, L. V. Short-Range Comput. Chem. 2015, 36, 1473−1479.
Effective Potentials for Ionic Fluids. J. Chem. Phys. 1986, 84, 2290− (41) Parez, S.; Guevara-Carrion, G.; Hasse, H.; Vrabec, J. Mutual
2294. Diffusion in the Ternary Mixture of Water Plus Methanol Plus Ethanol
(20) Brooks, B. R.; Bruccoleri, R. E.; Olafson, B. D.; States, D. J.; and its Binary Subsystems. Phys. Chem. Chem. Phys. 2013, 15, 3985−
Swaminathan, S.; Karplus, M. CHARMM - a Program for Macro- 4001.
molecular Energy, Minimization, and Dynamics Calculations. J. (42) Constantinescu, D.; Wichterle, I. Isothermal Vapour-Liquid
Comput. Chem. 1983, 4, 187−217. Equilibria and Excess Molar Volumes in the Binary Ethanol Plus Methyl
(21) Canongia Lopes, J. N.; Padua, A. A. H. CL&P: A Generic and Propanoate or Methyl Butanoate Systems. Fluid Phase Equilib. 2002,
Systematic Force Field for Ionic Liquids Modeling. Theor. Chem. Acc. 203, 71−82.
2012, 131, 1129.
(22) Mackerell, A. D. Empirical Force Fields for Biological
Macromolecules: Overview and Issues. J. Comput. Chem. 2004, 25,
1584−1604.
(23) Cornell, W. D.; Cieplak, P.; Bayly, C. I.; Gould, I. R.; Merz, K. M.;
Ferguson, D. M.; Spellmeyer, D. C.; Fox, T.; Caldwell, J. W.; Kollman,
P. A. A second generation force field for the simulation of proteins,
nucleic acids, and organic molecules (vol 117, pg 5179, 1995). J. Am.
Chem. Soc. 1996, 118, 2309−2309.
(24) Martínez, L.; Andrade, R.; Birgin, E. G.; Martínez, J. M.
PACKMOL: A Package for Building Initial Configurations for
Molecular Dynamics Simulations. J. Comput. Chem. 2009, 30, 2157−
2164.
(25) Schröder, C.; Steinhauser, O. Simulating Polarizable Molecular
Ionic Liquids with Drude Oscillators. J. Chem. Phys. 2010, 133, 154511.
(26) Schröder, C. Comparing Reduced Partial Charge Models with
Polarizable Simulations of Ionic Liquids. Phys. Chem. Chem. Phys. 2012,
14, 3089−4102.
(27) Goloviznina, K.; Canongia Lopes, J. N.; Costa Gomes, M.;
Padua, A. A. H. Transferable, Polarizable Force Field for Ionic Liquids.
J. Chem. Theory Comput. 2019, 15, 5858−5871.

1478 https://doi.org/10.1021/acs.jcim.1c01431
J. Chem. Inf. Model. 2022, 62, 1471−1478

You might also like