Bioinformatics ReviewBioinformatics Review
Notification Show More
Font ResizerAa
  •  Home
  • Docking
  • MD Simulation
  • Tools
  • More Topics
    • Softwares
    • Sequence Analysis
    • Algorithms
    • Bioinformatics Programming
    • Bioinformatics Research Updates
    • Drug Discovery
    • Phylogenetics
    • Structural Bioinformatics
    • Editorials
    • Tips & Tricks
    • Bioinformatics News
    • Featured
    • Genomics
    • Bioinformatics Infographics
  • Community
    • BiR-Research Group
    • Community Q&A
    • Ask a question
    • Join Telegram Channel
    • Join Facebook Group
    • Join Reddit Group
    • Subscription Options
    • Become a Patron
    • Write for us
  • About Us
    • About BiR
    • BiR Scope
    • The Team
    • Guidelines for Research Collaboration
    • Feedback
    • Contact Us
    • Recent @ BiR
  • Subscription
  • Account
    • Visit Dashboard
    • Login
Font ResizerAa
Bioinformatics ReviewBioinformatics Review
Search
Have an existing account? Sign In
Follow US
MD SimulationProtein-ligand complex simulation

Tutorial: MD simulation output analysis of a complex using GROMACS

Dr. Muniba Faiza
Last updated: December 31, 2020 4:33 pm
Dr. Muniba Faiza
Share
4 Min Read
MD simulation output analysis of a complex using GROMACS
SHARE

We have provided several tutorials on molecular dynamics (MD) simulation (please check further reading section). They include installation of simulation software, simulation of a simple protein, and a complex. In this article, we will analyze the GROMACS [1] output of MD simulation of a complex.

Contents
 1. RMSD2. RMSF3. Radius of gyration4. Hydrogen bondsProtein-ligand interactionsReferencesFurther Reading

We performed the MD simulation of human serum albumin (HSA) in complex with CMPF (Please refer to this article). This simulation was performed at 1 ns. We are going to use the same output files to analyze the results.

We have previously provided a detailed article on GROMACS [1] output analysis of MD simulation. Here, we are going to plot some important parameters based on which the complex simulation can be analyzed.

At first, correct the trajectory because the protein might appear broken or located on one side of the box. For that, use the trjconv module of GROMACS.vTo do this, we need .tpr and .xtc files as input resulted from the final MD run. Open the terminal, and type the following command:

$ gmx trjconv -s md_0_1.tpr -f md_0_1.xtc -o md_0_1_noPBC.xtc -pbc mol -center

When prompted, type “1” for selecting “Protein” as the group to be centered and “0” for “System”. It will generate md_0_1_noPBC.xtc as output that will be used for the analysis as shown below.

 1. RMSD

$ gmx rms -s md_0_1.tpr -f md_0_1_noPBC.xtc -o rmsd.xvg -tu ns

here, -tu refers to time units.

When prompted, type “4” for selecting “Backbone” and “0” for “System”. It will generate rmsd.xvg file that can be plotted using xmgrace software. The RMSD plot for this simulation looks like the one shown in the above-mentioned tutorial.

2. RMSF

$ gmx rmsf -f md_0_1_noPBC.xtc -s md_0_1.tpr -o rmsf.xvg

When prompted, type “1” for “Protein”.

3. Radius of gyration

$ gmx gyrate -f md_0_1_noPBC.xtc -s md_0_1.tpr -o gyrate.xvg

When prompted, type “1” for protein.

4. Hydrogen bonds

gmx hbond module is used to analyze hydrogen bonds that are calculated on the basis of cutoffs for the angle Hydrogen – Donor-Acceptor and the distance Donor-Acceptor (or Hydrogen – Acceptor).

$ gmx hbond -f md_0_1_noPBC.xtc -s md_0_1.tpr -num -dist

here, -num calculates the number of hydrogen bonds and -dist calculates the average distance among them.

When prompted, select Protein and Ligand. This will display the status of hydrogen bonds between the protein and the ligand. This tells about the stability of hydrogen bonds between the protein and the ligand.

Protein-ligand interactions

If you want to see whether a hydrogen bond is present between the protein and the ligand during the complete simulation, then find the interaction between the ligand and the binding residues present in the pocket. For example, the binding residue in the pocket is Tyr150, then using the gmx distance module, you can find the hydrogen bond distance between the hydroxyl group of ligand (C1F) and the carbonyl O atom of the receptor (Tyr150).

$ gmx distance -s md_0_10.tpr -f md_0_10_center.xtc -select 'resname "C1F" and name OAB plus resid 150 and name OE1' -oall

here, -oall represents all distances as a function of time.

These are some basic operations that you can perform to analyze protein-ligand complex simulation using GROMACS modules.


References

  1. Abraham, M. J., Murtola, T., Schulz, R., Páll, S., Smith, J. C., Hess, B., & Lindahl, E. (2015). GROMACS: High performance molecular simulations through multi-level parallelism from laptops to supercomputers. SoftwareX, 1, 19-25.

Further Reading

  1. Tutorial: Molecular dynamics (MD) simulation using Gromacs.
  2. Tutorial: MD simulation output analysis of protein using GROMACS.
  3. Installing Gromacs on Ubuntu for MD Simulation
  4. MD Simulation using GROMACS: Things to remember
TAGGED:Gromacsmd simulationoutput analysisprotein-ligand complex simulation
Share This Article
Facebook Copy Link Print
ByDr. Muniba Faiza
Follow:
Dr. Muniba is a Bioinformatician based in New Delhi, India. She has completed her PhD in Bioinformatics from South China University of Technology, Guangzhou, China. She has cutting edge knowledge of bioinformatics tools, algorithms, and drug designing. When she is not reading she is found enjoying with the family. Know more about Muniba
Leave a Comment

Leave a Reply Cancel reply

You must be logged in to post a comment.

Starting in Bioinformatics? Do This First!
Starting in Bioinformatics? Do This First!
Tips & Tricks
[Editorial] Is it ethical to change the order of authors’ names in a manuscript?
Editorial Opinion
Installing bbtools on Ubuntu
[Tutorial] Installing BBTools on Ubuntu (Linux).
Sequence Analysis Software Tools
wes_data_analysis Whole Exome Sequencing (WES) Data visualization Toolkit
wes_data_analysis: Whole Exome Sequencing (WES) Data visualization Toolkit
Bioinformatics Programming GitHub Python

You Might Also Like

CHARMM installation on Ubuntu
MD SimulationMolecular dynamicsSoftwareTools

Installing CHARMM on Ubuntu

July 12, 2020
MD SimulationSoftwareTools

Tutorial: MD simulation output analysis of protein using GROMACS

April 6, 2023
Install gromacs with gpu acceleration
MD SimulationSoftware

Method-1: Installing GROMACS on Ubuntu with CUDA GPU Support

March 16, 2021
md simulation of protein-ligand complex
MD SimulationMolecular dynamicsProtein-ligand complex simulation

Tutorial: MD Simulation of a Protein-Ligand Complex using GROMACS

August 21, 2023
Copyright 2024 IQL Technologies
  • Journal
  • Customer Support
  • Contact Us
  • FAQs
  • Terms of Use
  • Privacy Policy
  • Cookie Policy
  • Sitemap
Welcome Back!

Sign in to your account

Username or Email Address
Password

Lost your password?

Not a member? Sign Up