This repository provides four notebooks for running molecular dynamics simulations on Google Colab.
-
Build_to_Google_Drive.ipynb
Installs GROMACS to your Google Drive, where it can be loaded by the other notebooks.
-
GROMACS_for_CHARMM-GUI.ipynb
Equilibrates a system prepared with CHARMM-GUI. This notebook unpacks aCHARMM-GUI.tgz
archive from "Solution Builder." Optionally, it can merge in an archive from "Ligand Reader," allowing for piecewise preparation of protein-ligand systems.
-
GROMACS_for_production.ipynb
Starts or resumes a production simulation.
-
Trajectory_analysis_tools.ipynb
Calculates data that can be derived from a production simulation trajectory, such as centroid structures, RMSDs, and interaction energies.
All inputs and outputs are stored on your Google Drive.
The following is a quick-start guide describing how to simulate a docked protein-ligand complex.
-
Find or make a protein structure.
It should be complete (no gaps in the chain), though it's fine if a small number of residues at the termini are missing. You might use the Protein Data Bank or the AlphaFold Protein Structure Database.
↪protein.pdb
-
Dock a ligand to the protein.
You might use AutoDock Vina. If you need to convert the inputs to.mol2
or.pdbqt
, or the output to.sdf
, you might use Open Babel.
↪docked_ligand.sdf
-
Process the protein in CHARMM-GUI Solution Builder or, if it's a membrane protein, Membrane Builder.
The protein structure uploaded must be the one docked against (so its atomic coordinates line up with the ligand's). There is typically no need to change default settings or suggested values, except that you must enable GROMACS compatible outputs when you reach the last step.
↪protein_CHARMM.tgz
-
Process the docked ligand in CHARMM-GUI Ligand Reader.
The ligand structure uploaded must be the output from docking (so its atomic coordinates line up with the protein's). You must keep the default residue name:LIG
for a custom ligand, or the canonical name for a ligand already parameterised in the CHARMM36 forcefield.
↪docked_ligand_CHARMM.tgz
-
Upload the
.tgz
archives to Google Drive.
↪{GoogleDrive}/protein_CHARMM.tgz
and{GoogleDrive}/docked_ligand_CHARMM.tgz
-
Install GROMACS-on-Colab to your Google Drive using
Build_to_Google_Drive.ipynb
.
↪{GoogleDrive}/gromacs-on-colab/
-
Merge and equilibrate the protein and ligand using
GROMACS_for_CHARMM-GUI.ipynb
.
↪{GoogleDrive}/protein-ligand_project_folder/
, containingconf.gro
and other inputs for GROMACS -
Run the production simulation using
GROMACS_for_production.ipynb
.
↪{GoogleDrive}/protein-ligand_project_folder/sim_reference.xtc
-
Visualise the trajectory.
This is typically achieved by loadingconf.gro
andsim_reference.xtc
into a molecular visualisation software. You might use VMD. -
Optionally, analyse the trajectory using
Trajectory_analysis_tools.ipynb
.
These utilities allow you to compute the representative centroid frame for a timespan; to measure and plot the evolution of an observable, such as an interatomic distance or the RMSD of a group; or to summarise the interaction energy terms at a given time.