3 <TITLE>Getting started - Peptide
</TITLE>
4 <LINK rel=stylesheet
href=
"style.css" type=
"text/css">
5 <BODY text=
"#000000" bgcolor=
"#FFFFFF" link=
"#0000FF" vlink=
"#990000" alink=
"#FF0000">
6 <TABLE WIDTH=
"98%" NOBORDER
>
8 <TABLE WIDTH=
400 NOBORDER
>
10 <a href=
"http://www.gromacs.org/"><img SRC=
"../images/gmxlogo_small.jpg"BORDER=
0 height=
133 width=
116></a></td>
11 <td ALIGN=LEFT VALIGN=TOP WIDTH=
280><br><h2>Getting started - Peptide
</h2>
12 <font size=-
1><A HREF=
"../online.html">Main Table of Contents
</A></font><br><br></td>
13 </TABLE></TD><TD WIDTH=
"*" ALIGN=RIGHT VALIGN=BOTTOM
><p><B>VERSION
4.0<br>
14 Sun
18 Jan
2009</B></td></tr></TABLE>
19 <li><a href=
"#pdb2gmx">Generating a topology file
</a>
20 <li><a href=
"#solvate">Solvate the peptide
</a>
21 <li><a href=
"#indexfile">Generate an index file
</a>
22 <li><a href=
"#em">Energy minimization
</a>
23 <li><a href=
"#posres">Molecular dynamics with position restraints
</a>
24 <li><a href=
"#full">Unrestrained molecular dynamics
</a>
25 <li><a href=
"#analysis">Analysis of trajectory files
</a>
28 <A NAME=
"spep"><H2>Ribonuclease S-peptide
</A></H2>
30 <p>Ribonuclease A is a digestive enzyme, secreted by the pancreas. The enzyme
31 can be cleaved by subtilisin at a single peptide bond to yield
32 Ribonuclease-S, a catalytically active complex of an S-peptide moiety
33 (residues
1-
20) and an S-protein moiety (residues
21-
124), bound together
34 by multiple non-covalent links (
<A HREF=#stryer88
>Stryer,
1988</A>).
36 The S-Peptide has been studied in many ways, experimentally
37 as well as theoretically (simulation) because of the high a-helix
38 content in solution, which is remarkable in such a small peptide.
40 All the files of speptide are stored in the directory
<TT>
41 tutor/speptide
</TT>. First go to this directory:cd speptide
43 To be able to simulate the S-Peptide we need a starting structure. This can
44 be taken from the protein data bank. There are a number of different
45 structure for Ribonuclease S, from one of which we have cut out the
46 first
20 residues, and stored it in
47 <TT><a href=
"pdb.html">speptide.pdb
</a></TT>.
48 Have a look at the file
50 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
52 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
53 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
55 <tt> more speptide.pdb
62 If you have access to a molecular
63 graphics program such as rasmol,
64 you can look at the molecule on screen, eg:
66 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
68 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
69 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
71 <tt> rasmol speptide.pdb
79 The following steps have to be taken to perform a simulation of the peptide.
81 <li> Convert the pdb-file
<a href=
"pdb.html">speptide.pdb
</a>
82 to a GROMACS structure file and a GROMACS topology file.
83 <li> Solvate the peptide in water
84 <li> Perform an energy minimization of the peptide in solvent
85 <li> Add ions if necessary (we will omit this step here)
86 <li> Perform a short MD run with position restraints on the peptide
87 <li> Perform full MD without restraints
91 We will describe in detail how such a simulation can be done,
92 starting from a pdb-file.
94 <P><H3><A NAME=
"pdb2gmx">
95 Generate a topology file (
<tt><a href=
"top.html">.top
</a></tt>) from the pdb-file (
<tt><a href=
"pdb.html">.pdb
</a></TT>)
</a>
98 Generate a molecular topology and a structure file in
99 format. This can be done with the
<a href=
"pdb2gmx.html">pdb2gmx
</a> program:
101 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
103 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
104 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
106 <tt> pdb2gmx -f speptide.pdb -p speptide.top -o speptide.gro
112 Note that the correct file extension are added automatically to the
113 filenames on the command line.
114 You will only be asked to choose a forcefield, choose
0, but you can also
115 have
<a href=
"pdb2gmx.html">pdb2gmx
</a> ask you
116 about protonation of residues, and about protonation of N- and C-terminus.
119 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
121 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
122 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
130 to see the available options.
132 The
<a href=
"pdb2gmx.html">
133 pdb2gmx
</a> program has generated a topology file
134 <TT><a href=
"top.html">speptide.top
</a></TT> and a
135 GROMACS structure file
<tt><a href=
"gro.html">speptide.gro
</a></tt> and it will
137 positions. The
<tt>-p
</tt> and
<tt>-o
</tt> options with he
138 filenames are optional; without them the files
<TT><a href=
"top.html">topol.top
</a></TT> and
<TT>
139 <a href=
"gro.html">conf.gro
</a></TT> will be generated.
140 Now have a look at the output from
<a href=
"pdb2gmx.html">pdb2gmx
</a>,
142 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
144 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
145 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
147 <tt> more speptide.gro
153 You will see a close resemblance to the
<a href=
"pdb.html">pdb
</a> file, only the layout of
154 the file is a bit different.
155 Also do have a look at the topology
157 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
159 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
160 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
162 <tt> more speptide.top
168 You will see a large file containing the atom types, the physical
169 bonds between atoms, etcetera.
171 <P><H3><A NAME=
"solvate">
172 Solvate the peptide in a periodic box filled with water
</A></H3><p>
173 This is done using the programs
174 <a href=
"editconf.html">editconf
</a> and
175 <a href=
"genbox.html">genbox
</a>.
176 <a href=
"editconf.html">editconf
</a>
177 will make a rectangular box with empty space of user specified size
179 <a href=
"genbox.html">genbox
</a>
180 will read the structure file and fill the box with water.
182 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
184 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
185 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
187 <tt> editconf -f speptide -o -d
0.5<BR>
188 genbox -cp out -cs -p speptide -o b4em
194 The program prints some lines of user information, like the volume of
195 the box and the number of water molecules added to your
196 peptide.
<TT><a href=
"genbox.html">genbox
</a></TT>
197 also changes the topology file
198 <TT><a href=
"top.html">speptide.top
</a></TT> to include
199 these water molecules in the topology. This can been seen by looking
201 <TT><a href=
"top.html">speptide.top
</a></TT> file
203 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
205 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
206 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
208 <tt> tail speptide.top
214 You will see some lines like
221 where
<tt>N
</tt> is the number of water molecules added to your system by
222 <TT><a href=
"genbox.html">genbox
</a></TT>.
225 It is also possible to solvate a peptide in another solvent such as
226 dimethylsulfoxide (DMSO), as has been done by
227 <A HREF=#mierke91
>Mierke & Kessler,
1991</A>.
229 <P><H3><A NAME=
"indexfile">Generate index file (
<TT><a href=
"ndx.html">.ndx
</a></TT> extension)
</A></H3>
231 By default, most GROMACS programs generate a set of index groups to select
232 the most common subsets of atoms from your system (e.g. Protein, Backbone,
233 C-alpha's, Solute, etc.).
234 For the special cases when you need to select other groups than the
235 default ones, an
<a href=
"ndx.html">index file
</a>
236 can be generated using
<a href=
"make_ndx.html">make_ndx
</a>.
237 This is an interactive program that lets you manipulate molecules,
238 residues and atom. It's use should be self-explanatory. To invoke the
241 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
243 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
244 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
246 <tt> make_ndx -f b4em
252 but don't bother for now.
254 <P><H3><A NAME=
"em">Perform an energy minimization of the peptide in solvent
</A></H3>
256 Now we have to perform an
<EM>energy minimization
</EM> of the
257 structure to remove the local strain in the peptide (due to generation
258 of hydrogen positions) and to remove bad Van der Waals contacts
259 (particles that are too close). This can be done with the
260 <TT><a href=
"mdrun.html">mdrun
</a></TT> program which
261 is the MD and EM program. Before we can use the
262 <TT> <a href=
"mdrun.html">mdrun
</a></TT> program
263 however, we have to preprocess the topology file (
264 <TT><a href=
"top.html">speptide.top
</a></TT>), the
266 <TT><a href=
"gro.html">speptide.gro
</a></TT>) and a
267 special parameter file (
<TT><a href=
"mdp_opt.html">em.mdp
</a></TT>). Check
268 the contents of this file
270 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
272 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
273 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
281 Preprocessing is done with the preprocessor called
282 <TT><a href=
"grompp.html">grompp
</a></TT>. This reads
283 up the files just mentioned:
286 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
288 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
289 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
291 <tt> grompp -v -f em -c b4em -o em -p speptide
297 In this command the
<tt>-v
</tt> option turns on verbose mode, which
298 gives a little bit of clarifying info on what the program is doing.
299 We now have made a
<EM>run input file
</EM> (
<TT><a href=
"tpr.html">em.tpr
</a></TT>) which
300 serves as input for the
301 <TT><a href=
"mdrun.html">mdrun
</a></TT> program. Now
302 we can do the energy minimization:
304 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
306 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
307 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
309 <tt> mdrun -v -s em -o em -c after_em -g emlog
315 In this command the
<tt>-v
</tt> option turns on verbose mode again.
316 The
<tt>-o
</tt> option sets the filename for the trajectory file,
317 which is not very important in energy minimizations. The
<tt>-c
</tt>
318 option sets the filename of the structure file after energy
319 minimization. This file we will subsequently use as input for the MD
320 run. The energy minimization takes some time, the amount depending on
321 the CPU in your computer, the load of your computer, etc. The
322 <TT><a href=
"mdrun.html">mdrun
</a></TT> program is
323 automatically
<EM>niced
</EM>; it runs at low priority. All programs
324 that do extensive computations are automatically run at low
325 priority. For most modern workstations this computation should be a
326 matter of minutes. The minimization is finished when either the
327 minimization has converged or a fixed number of steps has been
328 performed. Since the system consists merely of water, a quick check
329 on the potential energy should reveal whether the minimization was
330 successful: the potential energy of
1 SPC water molecule at
300 K is
331 <tt>-
42</tt> kJ mole
<sup>-
1</sup>. Since we have about
<tt>2.55e+03</tt>
332 SPC molecules the potential energy should be about
<tt>-
1.1e+5</tt> kJ
333 mol
<sup>-
1</sup>. If the potential energy after minimization is lower
334 than
<tt>-
1.1e+05</tt> kJ mol
<sup>-
1</sup> it is acceptable and the
335 structure can be used for MD calculations. After our EM calculation
336 the program prints something like:
338 STEEPEST DESCENTS converged to
2000
339 Potential Energy = -
1.19482e+05
341 which means our criterium is met, and we can proceed to the next step.
343 <P><H3><A NAME=
"posres">
344 Perform a short MD run with position restraints on the peptide
</A>
346 Position restrained MD means Molecular Dynamics in which a part of the
347 system is not allowed to move far off their starting positions. To be
348 able to run with position restraints we must add a section to the
349 <TT><a href=
"top.html">speptide.top
</a></TT> file,
350 describing which atoms are to be restrained. Such a section is
351 actually generated by the
352 <a href=
"pdb2gmx.html">pdb2gmx
</a> program. In the
353 topology file it looks like
356 #include
"posres.itp"<BR>
359 In the
<a href=
"top.html">topology file
</a> we use
360 conditional inclusion, i.e. only if a variable
<TT>POSRES
</TT> is set
361 in the preprocessor do we include the file, this allows us to use the
362 same topology file for runs with and without position restraints. In
363 the
<a href=
"mdp_opt.html"><TT>pr.mdp
</TT></a> parameter file
364 for the position restraints this variable is set indeed:
369 At last we can generate the input for the position restrained mdrun:
371 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
373 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
374 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
376 <tt> grompp -f pr -o pr -c after_em -r after_em -p speptide
382 Now it's
<a href=
"mdrun.html">MDrun
</a> time:
384 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
386 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
387 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
389 <tt> mdrun -v -s pr -e pr -o pr -c after_pr -g prlog
>& pr.job &
395 This run is started in the background (it will take a while), you
396 can watch how long it will take by typing:
398 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
400 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
401 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
409 With the
<tt>Ctrl-C
</tt> key you can kill the
<tt>tail
</tt> command.
410 A good check of your simulation is to see whether density and potential
411 energies have converged:
413 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
415 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
416 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
418 <tt> g_energy -f pr -o out -w
424 The
<a href=
"g_energy.html">
425 g_energy
</a> program will prompt you to select a number of energy terms
426 from a list. For potential energy type:
428 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
430 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
431 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
439 If you have the xmgr program installed it will automatically pop up on your
440 screen with the energy plot. You can do the same for the density
441 and other energy terms, such as Solvent-Protein interactions.
443 <P><H3><A NAME=
"full">Perform full MD without restraints
</A></H3>
444 <p>Full MD is very similar to the restrained MD as far as GROMACS is
445 concerned. Check out the
<TT><a href=
"mdp_opt.html">full.mdp
</a></TT> for details.
447 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
449 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
450 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
452 <tt> grompp -v -f full -o full -c after_pr -p speptide
458 Then we can start mdrunning
460 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
462 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
463 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
464 <tt> mdrun -v -s full -e full -o full -c after_full -g flog
>& full.job &
470 You should do similar convergence checks (and more!) as for the position
471 restrained simulation.
475 <P><H3><A NAME=
"analysis">Analysis
</A></H3>
477 We will not describe analysis in detail, because most analysis tools
478 are described in the Analysis chapter of the printed manual.
479 We just list a few of the possibilities within GROMACS. By now you should be
480 able to start programs yourself.
483 <LI><p> View the trajectory on your own X-screen (program
484 <a href=
"ngmx.html">ngmx
</a>).
486 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
488 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
489 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
491 <tt> ngmx -s pr -f full
497 <font color=
"red">What happens to the peptide?
</font>
501 <li><p>The Root Mean Square Deviation (RMSD) with respect to the crystal
503 <a href=
"g_rms.html">g_rms
</a>) is a measure of how well the
504 crystal (starting) structure is maintained in the simulation.
505 The RMSD at time t is computed as
506 <(
<b>r
</b>(t)-
<b>r
</b>(
0))
<sup>2</sup>><sup>1/
2</sup>
507 after performing a least squares super position of the structure at
508 time t onto the structure at time
0.
510 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
512 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
513 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
515 <tt> g_rms -s pr -f full -o rmsd
521 Select the
1 for the number of groups, and select Calpha (Ca) for fitting
522 and for computing the RMSD. View the output graph with xmgrace.
524 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
526 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
527 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
529 <tt> xmgrace rmsd.xvg
535 <font color=
"red">Does the RMSD
536 converge within the simulation? If not, what does this indicate?
</font>
539 <LI><p>The Radius of Gyration (Rg, program
540 <a href=
"g_gyrate.html">g_gyrate
</a>)) is a measure of the size of the
541 protein. It is computed as the mean square distance of atoms from the center
542 of mass of the molecule: Rg(t) = SUM
<sub>i=
1 .. N
</sub>
543 (
<b>r
</b><sub>i
</sub>-
<b>r
</b><sub>com
</sub>)
<sup>2</sup>
545 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
547 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
548 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
550 <tt> g_gyrate -s pr -f full -o gyrate
556 View the graph with xmgrace:
558 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
560 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
561 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
563 <tt> xmgrace gyrate.xvg
569 <font color=
"red">Does the radius of gyration change during the
573 <LI><p>The Ramachandran Plot shows whether the backbone torsion angles
574 (
φ/
ψ) of your
575 peptide are within the allowed region.
576 (program
<a href=
"g_rama.html">g_rama
</a>).
578 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
580 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
581 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
583 <tt> g_rama -s pr -f full -o rama
589 View the graph with xmgrace:
591 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
593 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
594 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
596 <tt> xmgrace rama.xvg
602 Here you have all the backbone torsion angles from the trajectory.
603 <font color=
"red">Are all the angles in the allowed region?
604 What kind of structure do the angles indicate?
</font>
607 <LI><p>A salt bridge analysis (program
608 <a href=
"g_saltbr.html">g_saltbr
</a>) will tell you whether
609 there are any saltbridges formed or broken during the simulation.
610 It will also tell you about repulsive electrostatic interactions.
612 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
614 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
615 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
617 <tt> g_saltbr -s pr -f full -t
0.5 -sep
623 This will generate four graphs (in xmgrace format). Two of them refer to
624 attractive interactions.
625 You can view the graphs with xmgrace:
627 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
629 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
630 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
631 <tt>xmgrace sb-GLU2:ARG10.xvg sb-GLU2:LYSH7.xvg -legend load
637 <font color=
"red">Which interaction is the strongest?
</font>
638 Look at the peptide molecule again (using rasmol).
639 <font color=
"red">Which atoms form the closest contact in the saltbridge?
644 <LI> Secondary Structure analysis (program
645 <a href=
"my_dssp.html">my_dssp
</a>).
646 This analysis uses the dssp (dictionary of secondary structure in proteins,
647 <A HREF=#kabsch83
>Kabsch & Sander,
1983</A>) software.
649 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
651 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
652 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
654 <tt> my_dssp -s pr -f full
660 Select protein when asked to select a group.
661 You can postprecess the output file with:
663 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
665 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
666 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
668 <tt> xpm2ps -f ss.xpm -o ss.eps
674 This will give you a postscript file which you can either print or
677 <table BORDER=
0 CELLSPACING=
0 CELLPADDING=
8 COLS=
3 WIDTH=
"100%" NOSAVE
>
679 <td WIDTH=
"2%" NOSAVE
><font color=
"#000000"></font></td>
680 <td WIDTH=
"80%" BGCOLOR=
"#000066" NOSAVE
><font color=
"#FFFFFF">
688 <font color=
"red">What happens to the Alpha helix (in blue)?
</font>
695 You have been witness of a full MD simulation starting from a pdb-file.
696 It's that easy, but then again, maybe it was not that easy. The
697 example presented here is a
<EM>real
</EM> example, this is how a
698 production run should be performed, the complexity is in the process
699 itself and not in the software (at least, that's our opinion).
</p>
702 <a href=
"protunf.html"><h3>Go to the next step
</h3></a>