@@ -21,42 +21,30 @@ Stretching a polymer
2121 :class: only-light
2222
2323The goal of this tutorial is to use GROMACS and solvate a small
24- hydrophilic polymer in a reservoir of water.
24+ hydrophilic polymer in a reservoir of water.
2525
2626An all-atom description is used for both polymer and water. The polymer is
27- PolyEthylene Glycol (PEG). Once the system is properly
28- equilibrated at the desired temperature and pressure, a force is applied
29- to both ends of the polymer. The evolution of the polymer length
30- is measured, and the energetics of the system is measured.
27+ PolyEthylene Glycol (PEG). Once the system is properly equilibrated at the
28+ desired temperature and pressure, a force is applied to both ends of the
29+ polymer. The evolution of the polymer length is measured, and the energetics
30+ of the system is analyzed. This tutorial was inspired by a publication by
31+ |Liese2017 | and coworkers, in which molecular dynamics simulations are
32+ compared with force spectroscopy experiments :cite: `lieseHydrationEffectsTurn2017 `.
3133
3234..
3335 (GROMOS 54A7 force
3436 field :cite:`schmid2011definition`)
3537 (SPC flexible model :cite:`wu2006flexible`)
3638
37-
38-
39- This tutorial was inspired by a |Liese2017 | by Liese and coworkers, in which
40- molecular dynamics simulations are
41- compared with force spectroscopy experiments :cite: `liese2017hydration `.
42-
43- .. |Liese2017 | raw :: html
44-
45- <a href="https://doi.org/10.1021/acsnano.6b07071" target="_blank">publication</a>
46-
4739.. include :: ../../non-tutorials/recommand-salt.rst
4840.. include :: ../../non-tutorials/needhelp.rst
4941.. include :: ../../non-tutorials/GROMACS2024.2.rst
5042
5143Prepare the PEG molecule
5244========================
5345
54- Download the *peg.gro * file for the PEG molecule by clicking |download_H2O.data |.
55- The *peg.gro * file can be visualized using vmd, by typing in a terminal:
56-
57- .. |download_H2O.data | raw :: html
58-
59- <a href="https://raw.githubusercontent.com/gromacstutorials/gromacstutorials-inputs/main/level2/stretching-a-polymer/cubic-box/peg.gro" target="_blank">here</a>
46+ Download the |peg-gro | file for the PEG molecule by clicking. The
47+ **peg.gro ** file can be visualized using VMD, by typing in a terminal:
6048
6149.. code-block :: bash
6250
@@ -78,53 +66,35 @@ The *peg.gro* file can be visualized using vmd, by typing in a terminal:
7866 oxygen atoms (in red), and hydrogen atoms (in white). See
7967 the corresponding |video_peg_youtube |.
8068
81- .. |video_peg_youtube | raw :: html
82-
83- <a href="https://www.youtube.com/watch?v=8ldIHP175TI&t=9s" target="_blank">video</a>
69+ Save **peg.gro ** in a new folder. Next to **peg.gro ** create an empty
70+ file named **topol.top **, and copy the following lines into it:
8471
85- Save *peg.gro * in a new folder. Next to *peg.gro * create an empty
86- file named *topol.top *, and copy the following lines in it:
87-
88- .. code-block :: bw
72+ .. code-block :: bash
8973
9074 [ defaults ]
91- ; nbfunc comb-rule gen-pairs fudgeLJ fudgeQQ
92- 1 1 no 1.0 1.0
75+ ; nbfunc comb-rule gen-pairs fudgeLJ fudgeQQ
76+ 1 1 no 1.0 1.0
9377
9478 ; Include forcefield parameters
9579 # include "ff/charmm35r.itp"
9680 # include "ff/peg.itp"
97- #include "ff/tip3p.itp
81+ # include "ff/tip3p.itp"
9882
9983 [ system ]
10084 ; Name
101- PEG
85+ PEG
10286
10387 [ molecules ]
10488 ; Compound # mols
105- PEG 1
106-
107- Next to *conf.gro * and *topol.top *, create a folder named *ff/ *, and copy
108- the following 3 *.itp * files into it: |download_charmm35r.itp |, |download_peg.itp |,
109- and |download_tip3p.itp |.
110-
111- .. |download_charmm35r.itp | raw :: html
112-
113- <a href="https://raw.githubusercontent.com/gromacstutorials/gromacstutorials-inputs/main/level2/stretching-a-polymer/cubic-box/ff/charmm35r.itp" target="_blank">charmm35r.itp</a>
114-
115- .. |download_peg.itp | raw :: html
116-
117- <a href="https://raw.githubusercontent.com/gromacstutorials/gromacstutorials-inputs/main/level2/stretching-a-polymer/cubic-box/ff/peg.itp" target="_blank">peg.itp</a>
89+ PEG 1
11890
119- .. |download_tip3p.itp | raw :: html
120-
121- <a href="https://raw.githubusercontent.com/gromacstutorials/gromacstutorials-inputs/main/level2/stretching-a-polymer/cubic-box/ff/tip3p.itp" target="_blank">tip3p.itp</a>
122-
123- These 3 files contain the parameters for the PEG and the water molecules
91+ Next to **conf.gro ** and **topol.top **, create a folder named **ff/ **, and copy
92+ the following 3 **.itp ** files into it: |download_charmm35r.itp |, |download_peg.itp |,
93+ and |download_tip3p.itp |. These 3 files contain the parameters for the PEG and the water molecules
12494with oxygen (OW) and hydrogen (HW) atoms.
12595
126- Create an *inputs/ * folder next to *ff/ *, and create a new empty file
127- called *em.mdp *. Copy the following lines into it:
96+ Create an ** inputs/ ** folder next to ** ff/ * *, and create a new empty file
97+ called ** em.mdp * *. Copy the following lines into it:
12898
12999.. code-block :: bw
130100
@@ -142,11 +112,11 @@ called *em.mdp*. Copy the following lines into it:
142112 rvdw = 1
143113 pbc = xyz
144114
145- Most of these commands have been seen in previous tutorials. The most
146- important command is * integrator = steep * , which set the algorithm
147- used by GROMACS as the steepest-descent,
148- which moves the atoms following the direction of the largest forces
149- until one of the stopping criteria is reached :cite: `debyeNaeherungsformelnFuerZylinderfunktionen1909 `.
115+ Most of these commands have been seen in previous tutorials. Arguably the
116+ most important command is `` integrator = steep `` , which sets the algorithm
117+ used by GROMACS as the steepest-descent method. This algorithm moves the
118+ atoms following the direction of the largest forces until one of the stopping
119+ criteria is reached :cite: `debyeNaeherungsformelnFuerZylinderfunktionen1909 `.
150120
151121Run the energy minimization using GROMACS by typing in a terminal:
152122
@@ -155,8 +125,8 @@ Run the energy minimization using GROMACS by typing in a terminal:
155125 gmx grompp -f inputs/em.mdp -c peg.gro -p topol.top -o em-peg
156126 gmx mdrun -deffnm em-peg -v -nt 8
157127
158- The * -nt 8 * option limits the number of threads that GROMACS uses. Adjust
159- the number to your computer.
128+ The `` -nt 8 `` option limits the number of threads that GROMACS uses. Adjust
129+ the number to your computer.
160130
161131After the simulation is over, open the trajectory file with VMD by typing
162132in a terminal:
@@ -166,19 +136,20 @@ in a terminal:
166136 vmd peg.gro em-peg.trr
167137
168138 From VMD, the PEG molecule can be seen moving a little by the
169- steepest-descent algorithm.
139+ steepest-descent algorithm.
170140
171- Before adding the water, let us reshape the box and recenter the PEG molecule
172- in the box. As a first step, let us use a cubic box of
173- lateral size :math: `2.6 ~\text {nm}`.
141+ Before adding the water, let us reshape the box and recenter the PEG
142+ molecule in the box. As a first step, let us use a cubic box of lateral
143+ size :math: `2.6 ~\text {nm}`.
174144
175- .. code-block :: bash
145+ .. code-block :: bash
176146
177- gmx trjconv -f em-peg.gro -s em-peg.tpr -o peg-recentered.gro -center -pbc mol -box 2.6 2.6 2.6
147+ gmx trjconv -f em-peg.gro -s em-peg.tpr -o peg-recentered.gro -center
148+ -pbc mol -box 2.6 2.6 2.6
178149
179- Select * system * for both centering and output. The newly created *gro *
180- file named *peg-recentered.gro * will be used as a starting point
181- for the next step of the tutorial.
150+ Select `` system `` for both centering and output. The newly created ** . gro* *
151+ file named ** peg-recentered.gro ** will be used as a starting point for the
152+ next step of the tutorial.
182153
183154Solvate the PEG molecule
184155========================
0 commit comments