From fdf584249f42dd28c8e7d3dcf8faa41f81e9e6a1 Mon Sep 17 00:00:00 2001 From: Simon Gravelle Date: Fri, 21 Jun 2024 13:46:36 +0200 Subject: [PATCH] fixed various typo --- .../level1/breaking-a-carbon-nanotube.rst | 12 +-- .../tutorials/level1/lennard-jones-fluid.rst | 6 +- .../level2/nanosheared-electrolyte.rst | 16 +-- .../tutorials/level2/polymer-in-water.rst | 101 ++++++++---------- .../level3/free-energy-calculation.rst | 4 +- .../level3/reactive-silicon-dioxide.rst | 4 +- .../level3/water-adsorption-in-silica.rst | 6 +- 7 files changed, 69 insertions(+), 80 deletions(-) diff --git a/docs/sphinx/source/tutorials/level1/breaking-a-carbon-nanotube.rst b/docs/sphinx/source/tutorials/level1/breaking-a-carbon-nanotube.rst index f61ee98a..a3e55ba9 100644 --- a/docs/sphinx/source/tutorials/level1/breaking-a-carbon-nanotube.rst +++ b/docs/sphinx/source/tutorials/level1/breaking-a-carbon-nanotube.rst @@ -289,7 +289,7 @@ The LAMMPS input .. container:: justify The file *parm.lammps* is included in the - simulation by adding the following line to the *input.lammps* file: + simulation by adding the following line into the *input.lammps* file: .. code-block:: lammps @@ -340,7 +340,7 @@ Prepare the initial state .. container:: justify - Let us also change the box boundaries by adding the following line to *input.lammps*: + Let us also change the box boundaries by adding the following line into *input.lammps*: .. code-block:: lammps @@ -358,7 +358,7 @@ Prepare the initial state A displacement will be imposed on the edges of the CNT. To do so, let us isolate the atoms from the two edges and place them into groups named *rtop* and *rbot*, respectively. - Add the following lines to *input.lammps*: + Add the following lines into *input.lammps*: .. code-block:: lammps @@ -465,7 +465,7 @@ The molecular dynamics .. container:: justify Let us specify the thermalization and the dynamics of the - system. Add the following lines to *input.lammps*: + system. Add the following lines into *input.lammps*: .. code-block:: lammps @@ -792,7 +792,7 @@ Use of AIREBO potential .. container:: justify Then, let us import the LAMMPS data file, and set the - pair coefficients by adding the following lines to *input.lammps* + pair coefficients by adding the following lines into *input.lammps* .. code-block:: lammps @@ -875,7 +875,7 @@ Start the simulation First, as an equilibration step, let us set the velocity to 0 for the atoms of both edges. Let us fully constrain the edges. - Add the following lines to LAMMPS: + Add the following lines into LAMMPS: .. code-block:: lammps diff --git a/docs/sphinx/source/tutorials/level1/lennard-jones-fluid.rst b/docs/sphinx/source/tutorials/level1/lennard-jones-fluid.rst index f65d5368..e04b9105 100644 --- a/docs/sphinx/source/tutorials/level1/lennard-jones-fluid.rst +++ b/docs/sphinx/source/tutorials/level1/lennard-jones-fluid.rst @@ -327,7 +327,7 @@ Simulation Settings - :math:`\sigma_{12} = \sqrt{1.0 \times 3.0} = 1.732`. When necessary, cross-parameters can be explicitly specified - by adding the following line to the input file: *pair_coeff 1 2 0.707 1.732*. + by adding the following line into the input file: *pair_coeff 1 2 0.707 1.732*. This can be used for instance to increase the attraction between particles of type 1 and 2, without affecting the interactions between particles of the same type. @@ -378,7 +378,7 @@ Energy minimization .. container:: justify The system is now fully parametrized. Let us fill the two last remaining sections - by adding the following lines to *input.lammps*: + by adding the following lines into *input.lammps*: .. code-block:: lammps @@ -902,7 +902,7 @@ Restarting from a saved configuration .. container:: justify - Add the following lines to *input.md.lammps*. + Add the following lines into *input.md.lammps*. Note the absence of *Simulation settings* section, because the settings are taken from the *.data* file. diff --git a/docs/sphinx/source/tutorials/level2/nanosheared-electrolyte.rst b/docs/sphinx/source/tutorials/level2/nanosheared-electrolyte.rst index c1f75124..47be6307 100644 --- a/docs/sphinx/source/tutorials/level2/nanosheared-electrolyte.rst +++ b/docs/sphinx/source/tutorials/level2/nanosheared-electrolyte.rst @@ -103,7 +103,7 @@ System generation .. container:: justify - Let us create the box by adding the following lines to *input.lammps*: + Let us create the box by adding the following lines into *input.lammps*: .. code-block:: lammps @@ -150,7 +150,7 @@ System generation sub-regions corresponding respectively to the two solid walls, and create a larger region from the union of the two regions. Then, let us create atoms of type 5 (the wall) within the two - regions. Add the following lines to *input.lammps*: + regions. Add the following lines into *input.lammps*: .. code-block:: lammps @@ -178,7 +178,7 @@ System generation .. container:: justify - Add the following lines to *input.lammps*: + Add the following lines into *input.lammps*: .. code-block:: lammps @@ -347,7 +347,7 @@ System generation .. container:: justify To avoid high density and pressure, - let us add the following lines to *input.lammps* + let us add the following lines into *input.lammps* to delete a few of the water molecules: .. code-block:: lammps @@ -356,7 +356,7 @@ System generation .. container:: justify - Finally, add the following lines to *input.lammps*: + Finally, add the following lines into *input.lammps*: .. code-block:: lammps @@ -505,7 +505,7 @@ Energy minimization .. container:: justify Let us also print the atom positions in a *.lammpstrj* file by - adding the following line to *input.lammps*: + adding the following line into *input.lammps*: .. code-block:: lammps @@ -622,7 +622,7 @@ System equilibration .. container:: justify - Then, add the following lines to *input.lammps* for + Then, add the following lines into *input.lammps* for the trajectory visualization and output: .. code-block:: lammps @@ -772,7 +772,7 @@ Imposed shearing Finally, let us dump the atom positions, extract the velocity profiles using several *ave/chunk* commands, extract the force applied on the walls, and then run for :math:`200\,\text{ps}` - Add the following lines to *input.lammps*: + Add the following lines into *input.lammps*: .. code-block:: lammps diff --git a/docs/sphinx/source/tutorials/level2/polymer-in-water.rst b/docs/sphinx/source/tutorials/level2/polymer-in-water.rst index 06cf7981..35dc1934 100644 --- a/docs/sphinx/source/tutorials/level2/polymer-in-water.rst +++ b/docs/sphinx/source/tutorials/level2/polymer-in-water.rst @@ -21,20 +21,18 @@ Polymer in water .. container:: justify - The goal of this tutorial is to use LAMMPS and solvate a small + The goal of this tutorial is to use LAMMPS to solvate a small hydrophilic polymer (PEG - PolyEthylene Glycol) in a reservoir of water. .. container:: justify - An all-atom description is used for both PEG (GROMOS 54A7 force - field :cite:`schmid2011definition`) and water - (SPC/Fw model :cite:`wu2006flexible`) and the long - range Coulomb interactions are solved using the PPPM solver :cite:`luty1996calculating`. - Once the water reservoir is properly - equilibrated at the desired temperature and pressure, the polymer molecule - is added and a constant stretching force is applied to both - ends of the polymer. The evolution of the polymer length - is measured as a function of time. + Once the water reservoir is properly equilibrated at the desired temperature + and pressure, the polymer molecule is added and a constant stretching force + is applied to both ends of the polymer. The evolution of the polymer length + is measured as a function of time. The GROMOS 54A7 force field + :cite:`schmid2011definition` is used for the PEG, the SPC/Fw + model :cite:`wu2006flexible` is used for the water, and the long-range + Coulomb interactions are solved using the PPPM solver :cite:`luty1996calculating`. .. container:: justify @@ -58,7 +56,7 @@ Preparing the water reservoir .. container:: justify In this tutorial, the water reservoir is first prepared in the absence of - polymer. A rectangular box of water is created and + the polymer. A rectangular box of water is created and equilibrated at ambient temperature and ambient pressure. The SPC/Fw water model is used :cite:`wu2006flexible`, which is a flexible variant of the rigid SPC (simple point charge) @@ -84,10 +82,10 @@ Preparing the water reservoir .. container:: justify With the unit style *real*, masses are in grams per - mole, distances in Ångstroms, time in femtoseconds, energies + mole, distances in Ångstroms, time in femtoseconds, and energies in Kcal/mole. With the *atom_style full*, each atom is a dot with a mass and a charge that can be - linked by bonds, angles, dihedrals and/or impropers. The *bond_style*, + linked by bonds, angles, dihedrals, and/or impropers. The *bond_style*, *angle_style*, and *dihedral_style* commands define the potentials for the bonds, angles, and dihedrals used in the simulation, here *harmonic*. @@ -108,9 +106,9 @@ Preparing the water reservoir .. container:: justify - Finally, the *special_bonds* command cancels the - Lennard-Jones interactions between the closest - atoms of the same molecule. + Finally, the *special_bonds* command, which was already seen in + the previous tutorial, :ref:`carbon-nanotube-label`, sets the LJ and Coulomb + weighting factors for the interaction between neighboring atoms. .. admonition:: About *special bonds* :class: info @@ -128,24 +126,24 @@ Preparing the water reservoir With the *pair_style* named *lj/cut/coul/long*, atoms interact through both a Lennard-Jones (LJ) potential and - Coulombic interactions. The value of :math:`12\,\text{Å}` is + Coulomb interactions. The value of :math:`12\,\text{Å}` is the cutoff. .. admonition:: About cutoff in molecular dynamics :class: info - The cutoff of :math:`12\,\text{Å}` applies to both LJ and Coulombic + The cutoff of :math:`12\,\text{Å}` applies to both LJ and Coulomb interactions, but in a different way. For LJ *cut* interactions, atoms interact with each other only if they are separated by a distance smaller than the cutoff. For - Coulombic *long*, interactions between atoms closer than + Coulomb *long*, interactions between atoms closer than the cutoff are computed directly, and interactions between atoms outside that cutoff are computed in the reciprocal space. .. container:: justify - Finally, the *kspace* command defines the long-range solver for the (long) - Coulombic interactions. The *pppm* style refers to + Finally, the *kspace* command defines the long-range solver for the + Coulomb interactions. The *pppm* style refers to particle-particle particle-mesh :cite:`luty1996calculating`. .. admonition:: About PPPM @@ -167,8 +165,10 @@ Preparing the water reservoir Then, let us create a 3D simulation box of dimensions :math:`9 \times 3 \times 3 \; \text{nm}^3`, and make space for 9 atom types (2 for - the water molecule, and 7 for the polymer molecule), 7 bond types, 8 - angle types, and 4 dihedral types. + the water + 7 for the polymer), 7 bond types (1 for + the water + 6 for the polymer), 8 + angle types (1 for the water + 7 for the polymer), and 4 dihedral types + (for the polymer only). Copy the following lines into *input.lammps*: .. code-block:: lammps @@ -224,8 +224,8 @@ Preparing the water reservoir .. container:: justify Let us create water molecules. To do so, let us - define what a water molecule is using a molecule *template* called - *H2O-SPCFw.mol*, and then randomly create 1050 molecules. + import a molecule template called + *H2O-SPCFw.mol* and then let us randomly create 1050 molecules. Add the following lines into *input.lammps*: .. code-block:: lammps @@ -248,7 +248,7 @@ Preparing the water reservoir .. code-block:: bw - Created 1050 atoms + Created 3150 atoms .. container:: justify @@ -261,8 +261,8 @@ Preparing the water reservoir can be |download_FlexibleH2O| and saved in the *pureH2O/* folder. This template contains the necessary structural - information of a water molecule, such as the number of atoms, - the id of the atoms that are connected by bonds, by angles, etc. + information of a water molecule, such as the number of atoms, or the IDs + of the atoms that are connected by bonds, angles, etc. .. |download_FlexibleH2O| raw:: html @@ -284,9 +284,10 @@ Preparing the water reservoir .. container:: justify - The *reset_timestep* command is optional. It is used here - because the *minimize* command is usually performed over an arbitrary - number of steps. + In general, resetting the step of the simulation to 0 using the + *reset_timestep* command is optional. It is used here because the number + of iterations performed by the *minimize* command is usually not a round + number (since the minimization stops when one of four criteria is reached). .. container:: justify @@ -294,7 +295,7 @@ Preparing the water reservoir control the temperature of the molecules with a Nosé-Hoover thermostat and the pressure of the system with a Nosé-Hoover barostat :cite:`nose1984unified, hoover1985canonical, martyna1994constant`, - by adding the following line to *input.lammps*: + by adding the following line into *input.lammps*: .. code-block:: lammps @@ -345,7 +346,7 @@ Preparing the water reservoir Finally, let us set the timestep to 1.0 fs, and run the simulation for 20 ps by adding the - following lines to *input.lammps*: + following lines into *input.lammps*: .. code-block:: lammps @@ -409,9 +410,8 @@ Solvating the PEG in water .. container:: justify - Once the water reservoir is equilibrated, we can safely - include the PEG polymer in the water before performing the pull experiment - on the polymer. + Now that the water reservoir is equilibrated, we can safely + include the PEG polymer in the water. .. container:: justify @@ -472,10 +472,8 @@ Solvating the PEG in water .. container:: justify - Let us create a molecule called *pegmol* from - the molecule |download_PEG| - for the PEG molecule, and let us create a single molecule in the middle of - the box: + Download the molecule |download_PEG| for the PEG molecule, and then + create a single molecule in the middle of the box: .. |download_PEG| raw:: html @@ -489,7 +487,7 @@ Solvating the PEG in water .. container:: justify Let us create 2 groups to differentiate the PEG from the H2O, - by adding the following lines to *input.lammps*: + by adding the following lines into *input.lammps*: .. code-block:: lammps @@ -499,7 +497,7 @@ Solvating the PEG in water .. container:: justify Water molecules that are overlapping with the PEG must be deleted to avoid - future crashing. Add the following line to *input.lammps*: + future crashing. Add the following line into *input.lammps*: .. code-block:: lammps @@ -536,19 +534,10 @@ Solvating the PEG in water fix myat1 all ave/time 10 10 100 v_mytemp file temperature.dat fix myat2 all ave/time 10 10 100 v_myvol file volume.dat -.. container:: justify - - Let us also print the total enthalpy: - -.. code-block:: lammps - - variable myenthalpy equal enthalpy - fix myat3 all ave/time 10 10 100 v_myenthalpy file enthalpy.dat - .. container:: justify Finally, let us perform a short equilibration and print the - final state in a data file. Add the following lines to the data file: + final state in a data file. Add the following lines into the data file: .. code-block:: lammps @@ -618,7 +607,7 @@ Stretching the PEG molecule .. container:: justify Start the simulation from the equilibrated PEG-water system and include - again the parameter file by adding the following lines to the *input.lammps*: + again the parameter file by adding the following lines into the *input.lammps*: .. code-block:: lammps @@ -631,7 +620,7 @@ Stretching the PEG molecule as 2 groups containing only the 2 oxygen atoms of types 6 and 7, respectively. Atoms of types 6 and 7 correspond to the oxygen atoms located at the ends of the PEG molecule, which we are going to use to pull - on the PEG molecule. Add the following lines to the *input.lammps*: + on the PEG molecule. Add the following lines into the *input.lammps*: .. code-block:: lammps @@ -652,7 +641,7 @@ Stretching the PEG molecule .. container:: justify Let us use a single Nosé-Hoover thermostat applied to all the atoms by - adding the following lines to *input.lammps*: + adding the following lines into *input.lammps*: .. code-block:: lammps @@ -664,7 +653,7 @@ Stretching the PEG molecule Let us also print the end-to-end distance of the PEG, here defined as the distance between the groups *topull1* and *topull2*, as well as the temperature of the system - by adding the following lines to *input.lammps*: + by adding the following lines into *input.lammps*: .. code-block:: lammps diff --git a/docs/sphinx/source/tutorials/level3/free-energy-calculation.rst b/docs/sphinx/source/tutorials/level3/free-energy-calculation.rst index 229efaea..af78905e 100644 --- a/docs/sphinx/source/tutorials/level3/free-energy-calculation.rst +++ b/docs/sphinx/source/tutorials/level3/free-energy-calculation.rst @@ -132,7 +132,7 @@ System creation and settings .. container:: justify Let us define the simulation block and randomly add atoms - by adding the following lines to *input.lammps*: + by adding the following lines into *input.lammps*: .. code-block:: lammps @@ -197,7 +197,7 @@ System creation and settings Let us apply energy minimization to the system, and then impose the force :math:`F(x)` to all of the atoms in the simulation using the *addforce* command. - Add the following lines to *input.lammps*: + Add the following lines into *input.lammps*: .. code-block:: lammps diff --git a/docs/sphinx/source/tutorials/level3/reactive-silicon-dioxide.rst b/docs/sphinx/source/tutorials/level3/reactive-silicon-dioxide.rst index c85b38ae..1aa3404d 100644 --- a/docs/sphinx/source/tutorials/level3/reactive-silicon-dioxide.rst +++ b/docs/sphinx/source/tutorials/level3/reactive-silicon-dioxide.rst @@ -166,7 +166,7 @@ Prepare and relax Let us also print the charge in the *.log* file by using *thermo_style*, and create a *.lammpstrj* file for visualization. - Add the following lines to the *input.lammps*: + Add the following lines into the *input.lammps*: .. code-block:: lammps @@ -357,7 +357,7 @@ Deform the structure Let us run for 5000 steps without deformation, then apply the *fix deform* for elongating progressively the box along *x* during 25000 steps. Add the - following line to *input.lammps*: + following line into *input.lammps*: .. code-block:: lammps diff --git a/docs/sphinx/source/tutorials/level3/water-adsorption-in-silica.rst b/docs/sphinx/source/tutorials/level3/water-adsorption-in-silica.rst index 2b95f918..994fd10b 100644 --- a/docs/sphinx/source/tutorials/level3/water-adsorption-in-silica.rst +++ b/docs/sphinx/source/tutorials/level3/water-adsorption-in-silica.rst @@ -339,7 +339,7 @@ Cracking the silica and eventually crack. To do so, a loop based on the jump command is used. At every step of the loop, the box dimension over x will - be multiplied by a scaling factor 1.005. Add the following lines to + be multiplied by a scaling factor 1.005. Add the following lines into the *input.lammps*: .. code-block:: lammps @@ -651,7 +651,7 @@ Using hydrid potentials Let us delete the overlapping water molecules, and print the positions of the remaining atoms in a *.lammpstrj* file by adding the following - lines to *input.lammps*: + lines into *input.lammps*: .. code-block:: lammps @@ -665,7 +665,7 @@ GCMC simulation To prepare for the GCMC simulation, let us make the first equilibration step - by adding the following lines to *input.lammps*: + by adding the following lines into *input.lammps*: .. code-block:: lammps