0% found this document useful (0 votes)
19 views35 pages

BMS Lab 2

Uploaded by

lakshmi.r3403
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
19 views35 pages

BMS Lab 2

Uploaded by

lakshmi.r3403
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd

Biomolecular Simulation Laboratory Record

EXPERIMENT 01
HOMOLOGY MODELLING

Aim: To prepare the protein using modeller and other tools.

Theory: Protein data bank is a resource contains archive-information about the 3D shapes of proteins,
nucleic acids, and complex assemblies. PDB is the most reliable source to download the structures to
perform molecular dynamics simulation. However, one needs to understand the PDB file format
throughly to comment on the crystallisation process of the selected biomolecule. The following list
of points are extremely important while considering the crystal structure from PDB.

1. Always look for missing residues in the structure file. They should be added back to the structure
before proceeding further with simulation.
2. Understand the use of crystal water present in the structure file. If the crystal water do not play any
role in the simulation, then remove them to avoid modelling complications.
3. Sometimes, to get good quality crystals, the crystallographers mutate the structure in the non-
functional site of the protein. This information can be fetched by reading the corresponding literature.
If the structure is mutated, then they should be back mutated before proceeding with the dynamics.

To add missing residues and to back mutate, we have to perform protein modelling. Here, we use the
application of MODELLER software to model the protein.

Useful links:
1) [Link]
2) [Link]
3) [Link]
4) [Link]

PROCEDURE FOR HOMOLOGY MODELLING: Searching for structures related to P11597


* First, it is necessary to put the target P11597 sequence into the PIR format readable by
MODELLER. Go to Uniprot database and download FASTA sequences for P11597 and make it
format given.
>sp|P11597|CETP_HUMAN Cholesteryl ester transfer protein OS=Homo sapiens OX=9606
GN=CETP PE=1 SV=2
MLAATVLTLALLGNAHACSKGTSHEAGIVCRITKPALLVLNHETAKVIQTAFQRASYPDITGEKAMMLLGQVKYGLHN
IQISHLSIASSQVELVEAKSIDVSIQNVSVVFKGTLKYGYTTAWWLGIDQSIDFEIDSAIDLQINTQLTCDSGRVRTD
APDCYLSFHKLLLHLQGEREPGWIKQLFTNFISFTLKLVLKGQICKEINVISNIMADFVQTRAASILSDGDIGVDISL
TGDPVITASYLESHHKGHFIYKNVSEDLPLPTFSPTLLGDSRMLYFWFSERVFHSLAKVAFQDGRLMLSLMGDEFKAV
LETWGFNTNQEIFQEVVGGFPSQAQVTVHCLKMPKISCQNKGVVVNSS
VMVKFLFPRPDQQHSVAYTFEEDIVTTVQASYSKKKLFLSLLDFQITPKTVSNLTESSSESVQSFLQSMITAVGIPEV
MSRLEVVFTALMNSKGVSLFDIINPEIITRDGFLLLQMDFGFPEHLLVDFLQSLS

V Semester, Department of Biotechnology, SIT Page 1


Biomolecular Simulation Laboratory Record

Note: The first line contains the sequence code, in the format ">P1;code". The second line with ten
fields separated by colons generally contains information about the structure file, if applicable. Only
two of these fields are used for sequences, "sequence" (indicating that the file contains a sequence
without known structure) and "AMYA" (the model file name).

Figure: PDB Search

Selecting a template:
• Download template structure and save it in modeller folder
• Open the pdb flat file and remove header and heteroatoms

Figure: PDB flat file

V Semester, Department of Biotechnology, SIT Page 2


Biomolecular Simulation Laboratory Record

Figure: PDB flat file

* Save as .pdb (Ex: [Link])

1. Preparation of structure file.


The structure file should be in the form of .pdb file format. The PDB file of the template will
serve as the structure file in Modeller.

Figure: Atom Section

V Semester, Department of Biotechnology, SIT Page 3


Biomolecular Simulation Laboratory Record

2. Preparation of alignment file.


Alignment file should be in .ali extension file format. The aligned sequence in the alignment file
should be in PIR format.

Figure: [Link] file

3. Preparation of script file.

Figure: Python script file

Python based script is required run the modeller with .py file format. Modeller is not having any GUI
interface, it will run based on command prompt. (Sample script file is available in modeller’s example
folder)

4. Run modeller using the command.


python2.7 [Link]

V Semester, Department of Biotechnology, SIT Page 4


Biomolecular Simulation Laboratory Record

Figure: Files generated after running modeller

• Open the modeller generated file and visualize using pymol

Figure: Visualization using PYMOL

Conclusion:
The protein 2obd was modelled using modeller tool. Any one of the modelled structures
or files can be used as target for further analysis such as Protein preparation, Ligand Preparation etc.

V Semester, Department of Biotechnology, SIT Page 5


Biomolecular Simulation Laboratory Record

EXPERIMENT 2
PROTEIN PREPARATION AND PROTEIN MODELLING USING MODELLER
Aim: To prepare the protein using modeller and other tools.

Theory: Protein data bank is a resource contains archive-information about the 3D shapes of proteins,
nucleic acids, and complex assemblies. PDB is the most reliable source to download the structures to
perform molecular dynamics simulation. However, one needs to understand the PDB file format
throughly to comment on the crystallisation process of the selected biomolecule. The following list
of points are extremely important while considering the crystal structure from PDB.

1. Always look for missing residues in the structure file. They should be added back to the structure
before proceeding further with simulation.
2. Understand the use of crystal water present in the structure file. If the crystal water do not play any
role in the simulation, then remove them to avoid modelling complications.
3. Sometimes, to get good quality crystals, the crystallographers mutate the structure in the non-
functional site of the protein. This information can be fetched by reading the corresponding literature.
If the structure is mutated, then they should be back mutated before proceeding with the dynamics.
To add missing residues and to back mutate, we have to perform protein modelling. Here, we use the
application of MODELLER software to model the protein.
Useful links:
1) [Link]
2) [Link]
3) [Link]
4) [Link]
Procedure
Part 1:
# Target and Template identification:
1) Search for protein in NCBI databases by choosing appropriate search options.

Figure: Protein Search in NCBI

V Semester, Department of Biotechnology, SIT Page 6


Biomolecular Simulation Laboratory Record

2) What is the difference between Proteinase and Protease?


→Proteinases are a type of protease that cleave internal peptide links
→Proteases are the enzymes which cleave peptide bond in proteins

3) What is the accession number of the shortlisted search result?


→ 1BP1_A

4) Retrieve the FASTA sequence of the protein.

Figure: FASTA Sequence of protein of 1BP1

5) How many amino acids are present in the shortlisted protein?

→ 456Amino Acids

6) Perform NCBI Blast of the protein sequence against PDB database.

Figure: Result of Blast

V Semester, Department of Biotechnology, SIT Page 7


Biomolecular Simulation Laboratory Record

7) What is the percentage of Identity and Query coverage in the first hit of the search result.
→ Percentage identity of the first hit: 99.78% and Query coverage: 100%

Figure: Results of Sequences producing significant alignments

8) What is the accession number of the PDB ID?


→1BP1_A

9) Using the accession number open the structure in PDB

Figure: 3D Structure of 1BP1 in PDB database

Download FASTA sequence file and PDB structure file to your local desktop.

10) How many chains are present in the Resultant structure file → 1
11) Which chain is required to proceed further for model building? → Chain A

V Semester, Department of Biotechnology, SIT Page 8


Biomolecular Simulation Laboratory Record

12) Identify the missing residues in the structure file.


→ Yes, missing residues found in structure file

13) Is the crystal water is having any catalytic role in the enzyme? Comment on the same. →No

14) Is Model building is necessary? Yes

15) List out the missing residues in the selected chain of the protein.

Figure: Missing residues in PDB file

16) Prepare protein structure file by deleting unwanted sections in the PDB file.

17) Points to remember while preparing the structure file


a) Delete water molecule, if they are not playing any role in catalytic activity of the proteinase
b) The missing residues in the protein should be added back in the modelled structure.
c) The mutated residue in the non catalytic site should be back mutated (if any).

18) The modified template is now ready for modelling.

Part 2:
# Download and install modeller in your system
Part 3:
Working with modeller
1. Preparation of structure file.
The structure file should be in the form of .pdb file format. The PDB file of the Template will serve
as a structure file in Modeller.

V Semester, Department of Biotechnology, SIT Page 9


Biomolecular Simulation Laboratory Record

2. Preparation of alignment file.

Figure: [Link] file

Alignment file should be in .ali extension file format. The aligned sequence in the alignment file
should be in PIR format.

3. Preparation of script file.


Python based script is required to run the modeller with .py file format. Modeller does not have any
GUI interface; it will run based on command prompt. (Sample script file is available in modeller’s
example folder

Figure: [Link] file

V Semester, Department of Biotechnology, SIT Page 10


Biomolecular Simulation Laboratory Record

4. Run modeller using the command

Figure: Terminal result of modeller


Part 4:
Selection of the target structure:
1. One of the modelled structures is used as a target for further analysis.
2. Run the following command to convert the ligand file from .pdb [Link]

/usr/local/gromacs/bin/gmx pdb2gmx -f [Link] -o [Link] -water spce

Figure: Terminal result of Gromacs

V Semester, Department of Biotechnology, SIT Page 11


Biomolecular Simulation Laboratory Record

[Link] down the list of newly created files. [Link], [Link], [Link]

Figure: Files generated by GROMACS

3. Understand each and every file generated and comment on the same.
→[Link]: it is a gromacs readable file and exactly similar to a pdb file.
→[Link]: it is a position restrain file that contains the information of the force needed to be applied
on protein.
→[Link]: it contains the information of bond parameters such as bond length, bond angle, dihedral
angle, force parameters and non-bonded interaction parameters fetched from .itp file.

Result:
The protein 1BP1 was modelled using modeller tool. One of the modelled structures was used as
target for further analysis and converted the protein file .pdb [Link] and got three output files are
[Link], [Link] and [Link].

V Semester, Department of Biotechnology, SIT Page 12


Biomolecular Simulation Laboratory Record

EXPERIMENT 3
LIGAND PREPARATION AND GENERATION OF LIGAND FORCE FIELD

Aim: To prepare the ligand for molecular dynamics simulation and generation of the force field

Theory: Ligands are the most important aspect in understand the kinetics of an enzyme. The
ligands can be classified generally as substrates or inhibitors or enhancers of the enzymes.
However, it's important to understand the role of ligands in enzyme action. In molecular
dynamics simulations, the structure of the ligands is obtained from any ligand database.
PubChem is one of the important repositories of the chemical structures.
In molecular dynamics simulation, the force filed (library of parameters) for proteins is very
standard and it was developed by many scientific communities around the world. It is very
straight forward to design the force field of proteins, as every protein in nature is made of 20
amino acids. If one develops the parameters of 20 amino acids, which can easily adopted for all
proteins. But, in case of ligand this is not the case. Ligands are structurally very diverse and we
don’t have the force field (Library of parameters) ligands. Thus, one has to develop the force
filed of ligand of interest before use. Automated topology builder (ATB server) is one of the
important tool in designing the force field of ligands. Thus, SMILES notation form the PubChem
can be used in ATB server to develop the force filed of ligands.

Useful links:
1. [Link]
2. [Link]
3. [Link]

Procedure Part 1:
# Identification of ligand: The protein of interest is crystal structure of BPI, The human
bactericidal permeability-increasing protein
1. Identification of the suitable ligand against SARS-CoV-2 (COVID-19) main protease using
literature survey.
Ans: PC1
2. The main point while searching the ligands is to screen the possible leads, which are found to be
effective against the family of proteases.
3. Identification of the ligand using PubChem: Go to PubChem server, enter the ligand name in the
search box.

V Semester, Department of Biotechnology, SIT Page 13


Biomolecular Simulation Laboratory Record

Figure: Information about ligand from PubChem

4. Copy the canonical smiles.


5. Sign in to ATB server (use your academic email ID to register)
6. In the submit page, select “heteromolecule” as Molecule Type
7. Enter the net charge (Use PubChem website to identify the charge on the ligand molecule)

Figure: ATB server


8. Paste the canonical smiles obtained from the PubChem in the “Provide smiles” section.

Figure: Canonical SMILES

V Semester, Department of Biotechnology, SIT Page 14


Biomolecular Simulation Laboratory Record

9. Click on Translate 2D structure/smiles to 3D structure.

Figure: Translation of canonical/2D structure into 3D structure

10. Click on Transfer to submit page and then click Next.


11. The ATB database will also display any closest molecule present for the ligand in the result sheet.
If ATB displays so, then check for RMSD deviation and molecular composition. If the displayed
structure of ATB database is same as of ligand, then directly select the conformation.
12. If the ATB database doesn’t display any closest conformation of the ligand, then click on submit
the structure. The ATB database then generates topology of the new ligand. The result will be sent to
the registered e-mail address.
13. Select a confirmation and then click on the Show Molecule page.
14. Then click on Molecular Dynamics (MD) files.
15. Select the GROMACS format.
16. Download the following files: GROMOS96 topology file [Ex: GROMACS G54A7FF
UnitedAtom (ITP file)], structure file [Ex:United-Atom PDB (optimised geometry)] and force field
Gromacs 4.5x-5.x.x 54a7

Figure: Molecular Dynamics files page of PC1 inhibitor

V Semester, Department of Biotechnology, SIT Page 15


Biomolecular Simulation Laboratory Record

17. Suitably edit the residue names in both .itp and .pdb files. (Do not proceed on your own: Ask your
instructor about this step)
18. Add hydrogen molecules to the docked ligand file. (If needed)
19. Retain the topology of ATB ligand file and confirmation of the docked file to which hydrogens
added.
20. Suitably edit the atom numbers of the [Link] (Do not proceed on your own: Ask your
instructor about this step)
21. Arrange the ligand coordinates according to the [Link] file.
22. Run the following command to convert the ligand file from
pdb to .gro /usr/local/gromacs/bin/gmx editconf -f [Link] -o [Link]

Figure: Command to covert Ligand file from pdb to gro

23. Note down the list of newly created files.

Figure: Files generated

V Semester, Department of Biotechnology, SIT Page 16


Biomolecular Simulation Laboratory Record

Figure: Pymol visualization


24. Understand each and every file generated and comment on the same.

Part-2
Questions

1) What is ATB?
Ans: ATB stands for Automated Topology Builder. ATB server is used to fetch the force field
for the specific ligand
2) Which confirmation did you choose in ATB and why?
Ans: I selected the conformation with the RMSD value, which is having lower deviation when
compared to the other available conformations
3) What does the .itp file contain?
Ans: It is an independent topology file which contains the information of the particular protein
or ligand.
4) What is force field?
Ans: Force field is a library of parameters where MD algorithm fetches required parameters
depending on the system of study.

5) What is -f and -o indicated in the command?


Ans: -f instructs to find the particular file and -o indicates to generate the specified file.
6) What do you mean by editconf ?
Ans: It is used to change the configuration of the structure file to .gro or .pfb file.
7) What is the difference between .pdb and .gro file?
Ans: .pdb - protein data bank format
.gro - gromacs readable format

V Semester, Department of Biotechnology, SIT Page 17


Biomolecular Simulation Laboratory Record

Results
Ligand preparation was completed. Force field compatible for both ligand and protein and ligand
parameters were downloaded from the ATB server. Gro file of the ligand was generated using the
editconf command.

V Semester, Department of Biotechnology, SIT Page 18


Biomolecular Simulation Laboratory Record

EXPERIMENT 4
PREPARATION OF THE PROTEIN LIGAND COMPLEX, VACUUM MINIMIZATION,
PERIODIC BOUNDARY CONDITION, SYSTEM SOLVATION, ADDING IONS AND
ENERGY MINIMIZATION

Aim: To prepare protein ligand complex followed by vacuum minimization, periodic boundary
condition, system solvation, adding ions and energy minimization.

Theory: Once the protein and ligands are ready, it is important to prepare the protein-ligand complex.
The force filed of protein alone or the force filed of ligand alone cannot be used for the simulation of
the complex. Thus, we need to have the force field of protein-ligand complex. This, force field can
be obtained from ATB server. Once the topology of Protein ligand complex is ready, we have to
perform vacuum minimization.
In the field of computational chemistry, energy minimization (also called energy optimisation,
geometry minimization, or geometry optimisation) is the process of finding an arrangement in space
of a collection of atoms where, according to some computational model of chemical bonding, the net
inter-atomic force on each atom is acceptably close to zero and the position on the potential energy
surface (PES) is a stationary point (described later). In general, finding global energy minimised state
of a protein ligand complex.
Here, we perform energy minimisation of the complex under vacuum condition followed by
minimisation under solvent condition. To have solvent condition we add water molecule in the
defined periodic boundary and neutralise the system with Na+ and Cl- ions. After minimization the
system will be ready for equilibration.

Procedure:
Part 1: # Complex preparation
1. Create a new file in the text editor as [Link].
2. Paste [Link] (complete) and [Link] (exclude first two lines and last line of [Link]) in
[Link] file.
3. Update the total number of atoms in the [Link] and retain the cartesian coordinates in the
last line.
4. SAVE.
5. How many atoms are present in the [Link] file? → 4668 atoms

Figure: Number of Atoms present in [Link] file

V Semester, Department of Biotechnology, SIT Page 19


Biomolecular Simulation Laboratory Record

# Preparation of [Link] file.


1. [Link] file is referred as topology file. The complete topology of the protein is present in the
[Link] file. However, the ligand topology is missing in the topology file.
2. The second step is to add the ligand topology in the [Link] file.
3. Open the [Link] file as prepared in the second experiment in the note pad.
4. Slowly scan through entire [Link] file (topology file of ligand) and compare with the proteins’s
topology file present in the [Link].
5. Identify the different sections present in the topology file of both ligand and protein.
6. Next, to import ligand topology into protein topology file ([Link]) to prepare topology of
[Link] file.
7. For this, add following lines in [Link] file; Include ligand topology #include “[Link]”
8. Add the ligand name and its molecule number in the appropriate section (molecule type) of the
topology ([Link]) file.
9. SAVE and EXIT

#Preparation of new_box.gro file.


1. Open [Link] in VMD
2. In VMD, Go to Extension→ TK console → type “pbc box”
3. Will the periodic box covers the entire protein within it? → No

Figure: [Link] file with in periodic box


4. If no, How to rectify the same.
5. We use the following command to keep protein at the centre of the periodic box.
/usr/local/gromacs/bin/gmx editconf -f [Link] -o [Link] -bt cubic -d 2.0 -c
6. Again, open the [Link] file in VMD, in VMD Go to Extension→ TK console → type “pbc
box”

V Semester, Department of Biotechnology, SIT Page 20


Biomolecular Simulation Laboratory Record

7. Will box cover the entire protein? → Yes

Figure: [Link] file fits completely in periodic box


8. Identify the different box types (other than Cubic) which can be adopted in MD simulations.

Part-2
#Vacuum Minimization
1. Files required for vacuum minimization is [Link] file, topology files, .gro file.
2. .mdp file is referred as molecular dynamics parameter file which hold the parameters of dynamics
run.
3. Comment on the various parameters present in the .mdp file.
/usr/local/gromacs/bin/gmx grompp -f [Link] -c [Link] -p [Link] -o protein-EM-
[Link]

Figure: [Link] file generated after running the command

V Semester, Department of Biotechnology, SIT Page 21


Biomolecular Simulation Laboratory Record

s/usr/local/gromacs/bin/gmx mdrun -v -deffnm protein-EM-vacuum -c protein-EM-


[Link]
/usr/local/gromacs/bin/gmx mdrun -v -deffnm protein-EM-vacuum

Figure: Files generated after running the command and vacuum minimization

4. Use the following command prompt to run the vacuum minimization.


5. Understand the role of various keywords used in the command prompt.
6. What is energy minimization and why it is essential in MD simulations?
→Energy minimization is a technique used in molecular dynamics (MD) simulations to optimize the
initial configuration of a system by minimizing its potential energy.

Part-3
#System solvation, adding ions and energy minimization with solvent.
1. The required files system solvation are .mdp file, .gro file, [Link] file
2. To solvate the system use the following command.

V Semester, Department of Biotechnology, SIT Page 22


Biomolecular Simulation Laboratory Record

/usr/local/gromacs/bin/gmx solvate -cp [Link] -cs [Link] -p [Link] -o


[Link]

Figure: [Link] file generated after running the command

3. Open [Link] file in VMD.


4. In VMD, Go to Extension→ TK console → type “pbc box”

Figure: [Link] file in VMD

5. Can you see the solvation in the periodic boundary box? → Yes

V Semester, Department of Biotechnology, SIT Page 23


Biomolecular Simulation Laboratory Record

6. Can you see the protein/DNA of interest along with water? → Yes

7. How many water molecules are added in this step? (To get the answer refer [Link] file)

Figure: Number of water molecules added


8. After, adding water, it's time to bring the structure for required pH.
9. For this, we add ions to the system using following command
/usr/local/gromacs/bin/gmx grompp -f [Link] -c [Link] -p [Link] -o [Link]
/usr/local/gromacs/bin/gmx genion -s [Link] -o solv_ions.gro -p [Link] -conc 0.15 - neutral
-pname NA -nname CL

Figure: Files generated after running the command

V Semester, Department of Biotechnology, SIT Page 24


Biomolecular Simulation Laboratory Record

10. How many ions are added in this step? (To get the answer refer [Link] file)

Figure: Number of ions added

11. Open solv_ions.gro file in VMD.


12. In VMD, Go to Extension→ TK console → type “pbc box”
13. Visualize ions in VMD.

Figure: [Link] file in VMD after adding ions


14. Finally, perform system minimization under solvent condition.
15. Use the following command to run energy minimisation.

V Semester, Department of Biotechnology, SIT Page 25


Biomolecular Simulation Laboratory Record

/usr/local/gromacs/bin/gmx grompp -f [Link] -c solv_ions.gro -p [Link] -o [Link]


/usr/local/gromacs/bin/gmx mdrun -v -deffnm em

Figure: Generation of [Link] file

16. How many steps it took to minimise? → 2265 steps

Figure: Total number of steps taken for energy minimization


17. Analyse the parameters of .mdp file? Comment on the parameters. (Note: All .mdp files can be
obtained by GROMACS tutorials: Protein-ligand simulation)
→ .mdp file has the parameters to run simulations, such as the steps set for mdrun and saving the
trajectories, algorithm to calculate velocity and position, cutoff range for considering the
neighbouring atoms.

V Semester, Department of Biotechnology, SIT Page 26


Biomolecular Simulation Laboratory Record

QUESTIONS
1) Expand VMD and PBC.
→ VMD- Visual Molecular Dynamics
PBC- Periodic Boundary Condiotions

2) What does the [Link] file contain?


→ It contains the topology information of both protein and ligand

3) What was the difference observed when [Link], [Link], [Link] and solv_ions.gro were
visualised in VMD?
→ [Link] file contains only information about protein-ligand topology and it is not fitted in
PBC box.
[Link] contains protein-ligand topology but it is fitted in the centre of PBC box.
[Link] file contains the information of protein-ligand and number of water molecules added
solv_ions.gro file contains the information of protein-ligand topology, water topology and the ions
topology added to [Link] file

4) Which file will be created using the keyword grompp?


→ .tpr file

5) What is -bt, -d, -c, -p, -cp and -cs indicated in the command?
→ -bt: box type
-d: equal
-c: call
-p: call [Link]
-cp: call and copy
-cs: call and save

6) Did you observe any changes in the topology file after the solvation and neutralisation?
→ Yes, the number of water molecules and ions added will be updated and noted at the end of files.
Water molecules added: 178379, NA: 502, CL: 514

Result:
The protein-ligand complex is prepared using [Link] and [Link] files. The ligand topology is
added in [Link] by including [Link] and periodic boundary box is built with system at centre
using gromacs commands. The system is exposed to vacuum minimization and is solvated using
solvate command. The ions are then added to the system using genion command to maintain pH. The
system’s energy is then minimized successfully.

V Semester, Department of Biotechnology, SIT Page 27


Biomolecular Simulation Laboratory Record

EXPERIMENT 5
SYSTEM EQUILIBRATION USING NVT AND NPT ENSEMBLE SYSTEM AND
PERFORMING MD RUN

Aim: To perform system equilibration and running simulation

Theory: In MD simulations, atoms of the macromolecules and of the surrounding solvent undergo a
relaxation that usually lasts for tens or hundreds of picoseconds before the system reaches a stationary
state. The initial nonstationary segment of the simulated trajectory is typically discarded in the
calculation of equilibrium properties. This stage of the MD simulation is called equilibration stage.
Equilibration protocols are still largely a matter of personal preference. Some protocols call for very
elaborate procedures involving gradually increasing temperature in a step-wise fashion while other
more aggressive approach simply use a linear temperature gradient and heat the system up to the
desired temperature.
In our example, we'll follow the protocol of equilibration in two stages. In the first stage, we will start
the system from a low temperature of 100 K and gradually heat up to 300 K over 10 picosecond of
simulation time. We will perform this stage of equilibration with the volume held constant. This type
of equilibrium is referred as NVT equilibrium. In the second stage we gradually maintain the required
atmospheric pressure and keep pressure as constant throughout the equilibration phase. This type of
equilibration is referred as NPT equalisations. Also, we use the position restrain on the atoms initially,
which are gradually reduced to zero over multiple NPT equilibration simulations.

Useful links:
1. [Link] Procedure

Part-1
#System equilibration
1. Understand the concept of ensemble, NPT ensemble and NVT ensemble systems.
2. Download [Link] file and [Link] file from suitable GROMACS tutorial.
3. Glance through both .mdp files.
4. Comment on the parameters of .mdp file and understand its use while running GROMACS.
5. Position restraining is an important aspect in MD simulations.
6. To position restrain the atoms, 1000 KJ/mol of external energy is used.
7. In MD simulation, we initially keep position restrain for all atoms followed by step-by-step release
of restrain on atoms. Finally, all atoms will be set free to run without any restrain
[Link] the position restrain file of ligands using the following command.

V Semester, Department of Biotechnology, SIT Page 28


Biomolecular Simulation Laboratory Record

/usr/local/gromacs/bin/gmx genrestr -f [Link] -o posre_ligand.itp -fc 1000 1000 1000

Figure: Generation of porse_ligand.itp file


9. Include position restrain in the topology file [Link]
;Lipid position restraints
#ifdef POSRES
#include “posre_ligand.itp”
#endif
10. Merging protein and ligand using the following command
➢ /usr/local/gromacs/bin/gmx make_ndx -f [Link] -o [Link]
➢ Select 1|13
➢ Press q and press enter

Figure: Merging protein and ligand file using the command which generates [Link] file

V Semester, Department of Biotechnology, SIT Page 29


Biomolecular Simulation Laboratory Record

11. System equilibration in NVT ensemble (position restrain 1000 KJ/mol is maintained in NVT
ensemble)
12. Use the following command to run NVT ensemble.
➢ /usr/local/gromacs/bin/gmx grompp -f [Link] -c [Link] -p [Link] -n [Link] -o [Link]
-r [Link]
➢ /usr/local/gromacs/bin/gmx mdrun -deffnm nvt -v

Figure: NVT run

13. The output of NVT ensemble equilibration will be used as input for NPT ensemble
14. To run NPT ensemble use following command
15. As mentioned earlier, the restrain should be released slowly.
16. For this, we perform NPT ensemble simulation for multiple times by reducing the position restrain
force gradually.
➢ /usr/local/gromacs/bin/gmx grompp -f [Link] -c [Link] -t [Link] -p [Link] -n [Link]
-o [Link]
➢ /usr/local/gromacs/bin/gmx mdrun -deffnm npt-1000 -v

V Semester, Department of Biotechnology, SIT Page 30


Biomolecular Simulation Laboratory Record

Figure: NPT run


17. Release restrain slowly decreasing the numbers from 1000 to 100, from 100 to 10, from 10 to 1
and then from 1 to 0 position restrain its file.
❏ vi [Link]
:%s/1000 1000 1000/100 100 100/g
:wq
❏ vi posre_ligand.itp
:%s/1000 1000 1000/100 100 100/g
:wq
Next run the following command for next NPT run with reduced force.
➢ /usr/local/gromacs/bin/gmx grompp -f [Link] -c [Link] -t [Link] -p [Link]-
n [Link] -o [Link]
➢/usr/local/gromacs/bin/gmx mdrun -deffnm npt-100 -v

Figure: Command used to generate [Link] file and npt-100-v run

V Semester, Department of Biotechnology, SIT Page 31


Biomolecular Simulation Laboratory Record

➢ /usr/local/gromacs/bin/gmx mdrun -deffnm npt-100 -v


❏ vi [Link]
:%s/100 100 100/10 10 10/g
:wq
❏ vi posre_ligand.itp
:%s/100 100 100/10 10 10/g
:wq
Next run the following command for next NPT run with reduced force.
➢ /usr/local/gromacs/bin/gmx grompp -f [Link] -c [Link] -t [Link] -p [Link] -n
[Link] -o [Link]
➢ /usr/local/gromacs/bin/gmx mdrun -deffnm npt-10 -v

Figure: Command used to generate [Link] file and npt-10-v run


❏ vi [Link]
:%s/10 10 10/1 1 1/g
:wq
❏ vi posre_ligand.itp
:%s/10 10 10/1 1 1/g
:wq
Next run the following command for next NPT run with reduced force.
➢ /usr/local/gromacs/bin/gmx grompp -f [Link] -c [Link] -t [Link] -p [Link] -n
[Link] -o [Link]
➢ /usr/local/gromacs/bin/gmx mdrun -deffnm npt-1 -v

V Semester, Department of Biotechnology, SIT Page 32


Biomolecular Simulation Laboratory Record

Figure: Command used to generate [Link] file and npt-1-v run


❏ vi [Link]
:%s/1 1 1/0 0 0/g
:wq
❏ vi posre_ligand.itp
:%s/1 1 1/0 0 0/g
:wq
Next run the following command for next NPT run with reduced force.
➢ /usr/local/gromacs/bin/gmx grompp -f [Link] -c [Link] -t [Link] -p [Link] -n
[Link] -o [Link]
➢ /usr/local/gromacs/bin/gmx mdrun -deffnm npt -v
18. Finally, after running all the steps, the system is ready for MD run

Part-2
#Production run
1. The production run should be performed in NPT ensemble for the whatever nano second is
required.
2. For this, download [Link] file form GROMACS tutorials.
3. However, the parameters of [Link] and [Link] file will be almost similar.
4. Finally use the following command for production run.
5. Use servers for the production run.

V Semester, Department of Biotechnology, SIT Page 33


Biomolecular Simulation Laboratory Record

➢ /usr/local/gromacs/bin/gmx grompp -f [Link] -c [Link] -r [Link] -t [Link] -p [Link] -


n [Link] -o md_out.tpr
➢ /usr/local/gromacs/bin/gmx mdrun -deffnm md_out -v

Figure: production run

Major steps involved:


1. Preparation of .mdp file for NVT equilibration
2. Running NVT simulation
3. Preparation of .mdp file for NPT equilibration
4. Running NPT simulation
5. Preparation of .mdp file for production run in NPT ensemble
6. Production run.
QUESTIONS
1) What is the full form of NPT and NVT?
→ NPT: Number of atoms, Pressure, Temperature
NVT: Number of atoms, Volume, Temperature

2) What is an ensemble system?


→ Ensemble system is a collection of assemblies containing the same number of atoms, some
volume, pressure and temperature.

V Semester, Department of Biotechnology, SIT Page 34


Biomolecular Simulation Laboratory Record

3) Give an example for the macroscopic and microscopic entities.


→ Macroscropic entity: Pressure, Volume, Temperature, Number of atoms etc
Microscopic entity: Position, Velocioty

4) Are there any variations present in the microscopic entities when the protein is in its static state?
→ Yes, the velocity changes as the bond length varies.

5) By keeping NPT and NVT constant, what are the other macroscopic parameters you can calculate?
→ By keeping NPT constant we can measure the variation in Energy, Volume and Chemical potential.
Whereas by keeping NPT constant we can measure the variation in Pressure, Energy and Chemical
Potential.

6) Mention the difference between .xtc and .trr files?


→.xtc and .trr files are the trajectory files with detailed information and compressed data respectively.

Result:
The system will be present minimized energy (Previous experiment) and then subjected to
equilibration using NVT and NPT ensembles. In NVT ensemble, the number of atoms, volume and
temperature are kept constant with 300K whereas in NPT ensemble, the number of atoms, pressure
and temperature are kept constant. The force is slowly released in NPT equilibration steps from
1000KJ/mol to 0KJ/mol. Finally the system is ready for production run and maintain the steps of
1130 in [Link].

V Semester, Department of Biotechnology, SIT Page 35

You might also like