Skip to content

Commit 841eae4

Browse files
committed
minor grammar correction
1 parent 80132a9 commit 841eae4

File tree

1 file changed

+48
-49
lines changed

1 file changed

+48
-49
lines changed

docs/sphinx/source/tutorials/tutorial3/stretching-a-polymer.rst

+48-49
Original file line numberDiff line numberDiff line change
@@ -187,8 +187,8 @@ And then launch the energy minimization again using:
187187
gmx grompp -f inputs/em.mdp -c peg-solvated.gro -p topol.top -o em
188188
gmx mdrun -deffnm em -v -nt 8
189189
190-
The *define = -DFLEXIBLE* option triggers the following *if* condition
191-
within the *tip3p.itp* file:
190+
The ``define = -DFLEXIBLE`` option triggers the following **if** condition
191+
within the **tip3p.itp** file:
192192

193193
.. code-block:: bw
194194
@@ -202,11 +202,11 @@ within the *tip3p.itp* file:
202202
; i j k funct angle force.c.
203203
2 1 3 1 104.52 628.02 104.52 628.02
204204
205-
With this *if* condition the water molecules
205+
With this **if** condition the water molecules
206206
behave as flexible. This is better because rigid molecules and
207207
energy minimization usually don't go along well. For the next molecular
208208
dynamics steps, rigid water molecules will be used by not including
209-
the *define = -DFLEXIBLE* command in the inputs.
209+
the ``define = -DFLEXIBLE`` command in the inputs.
210210

211211
Equilibrate the PEG-water system
212212
================================
@@ -215,7 +215,7 @@ Let use equilibrate the system in two steps: first a NVT simulation,
215215
with constant number of particles, constant volume, and imposed temperature,
216216
and second a NPT simulation with imposed pressure.
217217

218-
Within the *inputs/* folder, create a new input named *nvt-peg-h2o.mdp*,
218+
Within the **inputs/** folder, create a new input named **nvt-peg-h2o.mdp**,
219219
and copy the following lines into it:
220220

221221
.. code-block:: bw
@@ -255,24 +255,24 @@ Most of these commands have already been seen. In addition to the conventional
255255
*md* leap-frog algorithm integrator, long-range Coulomb and short-range
256256
van der Waals interactions, the LINCS constraint algorithm is used to maintain
257257
the hydrogen bonds as rigid. An initial temperature of :math:`300~K` is given
258-
to the system by the *gen-* commands, and the PEG is maintained in the center
259-
of the box by the *comm-mode* and *comm-grps* commands.
258+
to the system by the ``gen-`` commands, and the PEG is maintained in the center
259+
of the box by the ``comm-mode`` and ``comm-grps`` commands.
260260

261-
Launch the NVT simulation using:
261+
Launch the *NVT* simulation using:
262262

263263
.. code-block:: bash
264264
265265
gmx grompp -f inputs/nvt-peg-h2o.mdp -c em.gro -p topol.top -o nvt -maxwarn 1
266266
gmx mdrun -deffnm nvt -v -nt 8
267267
268-
The *maxwarn 1* option is used to avoid a GROMACS WARNING related to the
268+
The ``maxwarn 1`` option is used to avoid a GROMACS WARNING related to the
269269
centering of the PEG in the box.
270270

271-
Let us follow-up with the NPT equilibration. Duplicate the *nvt-peg-h2o.mdp*
272-
file into a new input file named *npt-peg-h2o.mdp*. Within *npt-peg-h2o.mdp*,
273-
Within the *npt-peg-h2o.mdp*, delete the lines related to the creation
271+
Let us follow-up with the NPT equilibration. Duplicate the **nvt-peg-h2o.mdp**
272+
file into a new input file named **npt-peg-h2o.mdp**. Within **npt-peg-h2o.mdp**,
273+
Within the **npt-peg-h2o.mdp**, delete the lines related to the creation
274274
of velocity as its better to keep the velocities generated during the
275-
NVT run:
275+
*NVT* run:
276276

277277
.. code-block:: bw
278278
@@ -281,7 +281,7 @@ NVT run:
281281
gen-seed = 65823
282282
283283
In addition to the removal the previous 3 lines, add the following lines
284-
to *npt-peg-h2o.mdp* to specify the isotropic barostat with imposed pressure
284+
to **npt-peg-h2o.mdp** to specify the isotropic barostat with imposed pressure
285285
of :math:`1~\text{bar}`:
286286

287287
.. code-block:: bw
@@ -292,25 +292,25 @@ of :math:`1~\text{bar}`:
292292
ref-p = 1.0
293293
compressibility = 4.5e-5
294294
295-
Run the NPT simulation, using the final state of the NVT simulation
296-
*nvt.gro* as starting configuration:
295+
Run the *NpT* simulation, using the final state of the *NVT* simulation
296+
**nvt.gro** as starting configuration:
297297

298298
.. code-block:: bash
299299
300300
${gmx} grompp -f inputs/npt-peg-h2o.mdp -c nvt.gro -p topol.top -o npt -maxwarn 1
301301
${gmx} mdrun -deffnm npt -v -nt 8
302302
303303
Let us observe the evolution of the potential energy of the system during the
304-
3 successive equilibration steps, i.e. the *em*, *nvt*, and *npt* steps,
305-
using the *gmx energy* command as follow:
304+
3 successive equilibration steps, i.e. the energy minimization, *NVT*, and *NpT* steps,
305+
using the ``gmx energy`` command as follow:
306306

307307
.. code-block:: bash
308308
309309
gmx energy -f em.edr -o energy-em.xvg
310310
gmx energy -f nvt.edr -o energy-nvt.xvg
311311
gmx energy -f npt.edr -o energy-npt.xvg
312312
313-
For each of the 3 *gmx energy* commands, select *potential*.
313+
For each of the 3 ``gmx energy`` commands, select ``potential``.
314314

315315
.. figure:: ../figures/level2/stretching-a-polymer/potential-energy-light.png
316316
:alt: Potential energy from molecular dynamics simulation in GROMACS
@@ -331,7 +331,7 @@ between the different atoms of the PEG molecules. This angle
331331
distribution will be used later as a benchmark to probe the effect of
332332
of the stretching on the PEG structure.
333333

334-
Create a new input named *production-peg-h2o.mdp*, and copy the following
334+
Create a new input named **production-peg-h2o.mdp**, and copy the following
335335
lines into it:
336336

337337
.. code-block:: bw
@@ -363,8 +363,8 @@ lines into it:
363363
comm-mode = linear
364364
comm-grps = PEG
365365
366-
This script resembles the *nvt-peg-h2o.mdp* input, but the duration and
367-
output frequency is different, and without the *gen-vel* commands.
366+
This script resembles the **nvt-peg-h2o.mdp** input, but the duration and
367+
output frequency is different, and without the ``gen-vel`` commands.
368368

369369
Run it using:
370370

@@ -373,17 +373,17 @@ Run it using:
373373
gmx grompp -f inputs/production-peg-h2o.mdp -c npt.gro -p topol.top -o production -maxwarn 1
374374
gmx mdrun -deffnm production -v -nt 8
375375
376-
First, create an index file called *angle.ndx* using the *gmx mk_angndx*
376+
First, create an index file called **angle.ndx** using the ``gmx mk_angndx``
377377
command:
378378

379379
.. code-block:: bash
380380
381381
gmx mk_angndx -s production.tpr -hyd no
382382
383-
The *angle.ndx* file generated contains groups with all the atoms
383+
The **angle.ndx** file generated contains groups with all the atoms
384384
involved by an angle constraint, with the exception of the hydrogen
385-
atoms due to the use of *-hyd no*. The atom ids selected in the groups
386-
can be seen from the *index.ndx* file:
385+
atoms due to the use of ``-hyd no``. The atom ids selected in the groups
386+
can be seen from the **index.ndx** file:
387387

388388
.. code-block:: bw
389389
@@ -393,8 +393,8 @@ can be seen from the *index.ndx* file:
393393
59 61 63 66 68 70 73 75 77 80 82 84
394394
395395
Here, each number corresponds to the atom index, as can be seen from the
396-
initial *peg.gro* file. For instance, the atom of *id 2* is a carbon atom,
397-
and the atom with *id 5* is an oxygen:
396+
initial **peg.gro** file. For instance, the atom of ``id 2`` is a carbon atom,
397+
and the atom with ``id 5`` is an oxygen:
398398

399399
.. code-block:: bw
400400
@@ -410,8 +410,8 @@ and the atom with *id 5* is an oxygen:
410410
1PEG H4 8 1.699 1.500 1.425 4.2893 1.6837 -0.9462
411411
(...)
412412
413-
Then, extract the angle distribution from the *production.xtc*
414-
file using *gmx angle*:
413+
Then, extract the angle distribution from the **production.xtc**
414+
file using ``gmx angle``:
415415

416416
.. code-block:: bash
417417
@@ -434,19 +434,18 @@ Select 1 for the O-C-C-O dihedral.
434434
Stretch on the polymer
435435
======================
436436

437-
Create a new folder named *elongated-box/* next to *cubic-box/*, and copy
438-
*ff/*, *inputs/*, *em-peg.gro*, and em-peg.tpr from *cubic-box/*
439-
into *elongated-box/*:
437+
Create a new folder named **elongated-box/** next to **cubic-box/**, and copy
438+
**ff/**, **inputs/**, **em-peg.gro**, and **em-peg.tpr** from **cubic-box/**
439+
into **elongated-box/**:
440440

441441
To leave space for the stretched PEG molecule, let us create an
442-
elongated box of length :math:`6~\text{nm}`
443-
along the *x* direction:
442+
elongated box of length :math:`6~\text{nm}` along the *x* direction:
444443

445444
.. code-block:: bash
446445
447446
gmx trjconv -f em-peg.gro -s em-peg.tpr -o peg-elongated.gro -center -pbc mol -box 6 2.6 2.6
448447
449-
Select *system* for both centering and output.
448+
Select ``system`` for both centering and output.
450449

451450
Then, follow the exact same steps as previously to solvate and equilibrate
452451
the system:
@@ -469,9 +468,9 @@ The index file
469468

470469
To apply a forcing to the ends of the PEG, one needs to create atom groups.
471470
Specificaly, we want to create two groups, each containing a single oxygen
472-
atom from the edges of the PEG molecules (with ID 82 and 5). In GROMACS,
471+
atom from the edges of the PEG molecules (with ``id 82`` and ``5``). In GROMACS,
473472
this can be done using and index file *.ndx*. Create a new index file
474-
named *index.ndx* using the *gmx make_ndx* command:
473+
named **index.ndx** using the ``gmx make_ndx`` command:
475474

476475
.. code-block:: bash
477476
@@ -486,8 +485,8 @@ When prompted, type the following 4 lines to create 2 additional groups:
486485
name 6 End1
487486
name 7 End2
488487
489-
Then, type *q* for quitting. The index file *index.ndx*
490-
contains 2 additional groups named *End1* and *End2*:
488+
Then, type ``q`` for quitting. The index file **index.ndx**
489+
contains 2 additional groups named **End1** and **End2**:
491490

492491
.. code-block:: bw
493492
@@ -509,7 +508,7 @@ The input file
509508

510509
Let us create an input file for the stretching of the PEG molecule.
511510

512-
Create a new input file named *stretching-peg-h2o.mdp* within *inputs/*,
511+
Create a new input file named **stretching-peg-h2o.mdp** within **inputs/**,
513512
and copy the following lines in it:
514513

515514
.. code-block:: bw
@@ -538,9 +537,9 @@ and copy the following lines in it:
538537
ref_t = 300 300
539538
tc_grps = PEG Water
540539
541-
So far, the script is similar to the previously created *production-peg-h2o.mdp*
542-
file, but without the *comm-mode* commands. To apply the constant forcing to
543-
the *End1* and *End2* groups, add the following lines to *production-peg-h2o.mdp*:
540+
So far, the script is similar to the previously created **production-peg-h2o.mdp**
541+
file, but without the ``comm-mode`` commands. To apply the constant forcing to
542+
the **End1** and **End2** groups, add the following lines to **production-peg-h2o.mdp**:
544543

545544
.. code-block:: bw
546545
@@ -561,18 +560,18 @@ the *End1* and *End2* groups, add the following lines to *production-peg-h2o.mdp
561560
The force constant is requested along the *x* direction only (Y N N),
562561
with a force constant :math:`k = 200~\text{kJ}~\text{mol}^{-1}~\text{nm}^{-1}`.
563562

564-
Launch the simulation using the *-n index.ndx* option for the *gmx grompp*
563+
Launch the simulation using the ``-n index.ndx`` option for the ``gmx grompp``
565564
command to refer to the previously created index file, so that GROMACS
566-
finds the *End1* and *End2* groups.
565+
finds the ``End1`` and ``End2`` groups.
567566

568567
.. code-block:: bash
569568
570569
gmx grompp -f inputs/stretching-peg-h2o.mdp -c npt.gro -p topol.top -o stretching -n index.ndx
571570
gmx mdrun -deffnm stretching -v -nt 8
572571
573-
Two data files named *stretching_pullf.xvg* and *stretching_pullx.xvg*
572+
Two data files named **stretching_pullf.xvg** and **stretching_pullx.xvg**
574573
are created during the simulation, and contain respectively the
575-
force and distance between the 2 groups *End1* and *End2* as a function
574+
force and distance between the 2 groups ``End1`` and ``End2`` as a function
576575
of time.
577576

578577
.. figure:: ../figures/level2/stretching-a-polymer/pull-position-light.png
@@ -601,7 +600,7 @@ by remeasuring the dihedral angle values:
601600
gmx mk_angndx -s stretching.tpr -hyd no -type dihedral
602601
gmx angle -n angle.ndx -f stretching-centered.xtc -od dihedral-distribution.xvg -binwidth 0.25 -type dihedral -b 20
603602
604-
Select 1 for the O-C-C-O dihedral. Here the option *-b 20* is used to disregard
603+
Select 1 for the O-C-C-O dihedral. Here, the option ``-b 20`` is used to disregard
605604
the first 20 pico-seconds of the simulation during which the PEG has not
606605
reach is final length.
607606

0 commit comments

Comments
 (0)