Abstract
Molecular dynamics (MD) simulation is a powerful computational tool used in biomolecular studies to investigate the dynamics, energetics, and interactions of a wide range of biological systems at the atomic level. GROMACS is a widely used free and open-source biomolecular MD simulation software recognized for its efficiency, accuracy, and extensive range of simulation options. However, the complexity of setting up, running, and analyzing MD simulations for diverse systems often poses a significant challenge, requiring considerable time, effort, and expertise. Here, we introduce CHAPERONg, a tool that automates the GROMACS MD simulation pipelines for protein and protein-ligand systems. CHAPERONg also integrates seamlessly with GROMACS modules and third-party tools to provide comprehensive analyses of MD simulation trajectories, offering up to 20 post-simulation processing and trajectory analyses. It also streamlines and automates established pipelines for conducting and analyzing biased MD simulations via the steered MD-umbrella sampling workflow. Thus, CHAPERONg makes MD simulations more accessible to beginner GROMACS users whilst empowering experts to focus on data interpretation and other less programmable aspects of MD simulation workflows. CHAPERONg is written in Bash and Python, and the source code is freely available at https://github.com/abeebyekeen/CHAPERONg. Detailed documentation and tutorials are available online at dedicated web pages accessible via https://abeebyekeen.com/chaperong-online.
Keywords: GROMACS, Umbrella sampling, MD trajectory analysis, Kernel density estimation, Free energy landscape
Graphical abstract
Highlights
-
•
Setting up and running GROMACS MDS can be complex, repetitive and challenging.
-
•
We introduce CHAPERONg, a tool that automates GROMACS-based MD simulations.
-
•
It automates conventional and enhanced sampling simulations for diverse systems.
-
•
CHAPERONg also offers automated extensive post-simulation trajectory analyses.
-
•
Thus, CHAPERONg simplifies the use of GROMACS for biomolecular simulations.
1. Introduction
Molecular dynamics (MD) simulation is a robust and valuable tool for studying the dynamic behavior, energetics, and interactions of diverse biological systems, including proteins, protein-ligand complexes, nucleic acids, and membrane lipids [1]. These simulations provide insights–in full atomic details and at precise temporal resolutions–into the dynamics, stability, and functional properties of biomolecules, complementing experimental observations and providing guidance for further investigations [2], [3]. GROMACS [4] is a widely used MD simulation software. It is one of the gold standards for biomolecular simulation not only because of its efficiency, accuracy, and extensive range of simulation options but also because it's a free and open-source software with a huge community of users and developers [5], [6]. MD simulation protocols typically consist of three main stages: system preparation, MD production or simulation run, and trajectory analysis (Fig. 1) [7]. While advances in computational power and resources have improved the capabilities of MD simulation tools, setting up and running MD simulations with GROMACS (and other MD simulation codes) still present several challenges [8].
GROMACS is a command-line program and, as with most other popular MD simulation engines, is characterized by limited accessibility to many researchers who, despite possessing the necessary domain knowledge to interpret the relevant computational results, may not be familiar with working on the command line [5], [6]. In addition, setting up and running MD simulations requires a lot of manual tasks, making the process time-consuming, labor-intensive, and error-prone. Since many of these steps are repetitive and programmable, automation tools would greatly minimize manual user interventions, thereby improving efficiency and empowering users (beginners and experts) to focus on other aspects like optimization of parameters, data analysis, and result interpretation [9].
Furthermore, MD simulations typically generate huge amounts of trajectory data, but processing the data into particularly meaningful, relevant, and informative forms often requires programming and data analysis skills [10], [11]. Thus, beginner and intermediate users with limited or no such skills are only able to gain superficial insights from MD output data in spite of MD simulation being a computation-intensive process. The ability to transform simulation data into more interpretable forms and consequently obtain optimally useful information would facilitate the gaining of relevant biological (structural and functional) insights from MD simulations [11].
In order to assuage the aforementioned challenges, several tools integrated into standalone or web-based graphical user interfaces (GUIs) have been developed to automate or simplify various steps or aspects of the GROMACS MD simulation process. The earliest GUI-based programs including GUIMACS [12], jSimMacs [13], and GROMITA [14] that offered some capability to carry out GROMACS MD simulation of protein (only) systems have not been updated for a long time, making them incompatible with recent GROMACS versions [6]. Other GUI-integrated plugins like Dynamics PyMOL plugin [5], [15], Enlighten2 (a PyMOL plugin and Python package) [16], and YAMACS (a YASARA plugin) [6] have such limitations as restrictions to the simulation of specific systems (protein only or protein complexes), support for only select force field(s), lack of trajectory analysis functions, non-trivial installation of dependencies, or the need to learn other software interfaces upon which they depend [16]. Existing web-based interfaces include MDWeb [17] and WebGro [18]; both of which offer MD simulation over limited timescales, and CHARMM-GUI [19]; a toolkit for generating input files for MD simulations using the CHARMM force field. MDWeb does not support the simulation of protein-ligand complexes, and for WebGro, the support is limited to the GROMOS force field. VisualDynamics [8] and BioBB-Wfs [9] are two recent web-based initiatives that also offer MD simulations over limited duration. While they are excellent platforms, they, however, only provide basic analyses of simulation trajectories. They also do not offer advanced simulation workflows (such as biased or enhanced sampling simulations).
In this work, we present CHAPERONg, a comprehensive automated pipeline for GROMACS MD simulations and trajectory analyses. CHAPERONg is a command-line interface to GROMACS that automates and streamlines the entire MD simulation protocols for protein, protein-ligand, and protein-DNA systems (Fig. 1). It supports ligand topology parameters obtained from popular external parameterization programs for the CHARMM, AMBER, GROMOS, and OPLS-AA force fields. CHAPERONg seamlessly integrates with GROMACS modules and third-party tools to enable an extensive automated workflow of up to 20 different post-simulation trajectory and end-point analyses. In addition, it automates the steered MD and umbrella sampling simulations, a biased enhanced simulation protocol often employed to overcome sampling limitations and investigate rare events. Thus, CHAPERONg would not only make MD simulation more accessible to beginner GROMACS users but also expand the toolset of experts by facilitating improved efficiency and providing a platform upon which advanced and customized analyses and scripting could be built.
2. Methods and code implementation
CHAPERONg has been developed using the Bash shell scripting and the Python 3 programming language. The framework and primary modules of the CHAPERONg source code were written using Bash shell scripting because GROMACS is a Linux-based software. This allows a seamless GROMACS-CHAPERONg integration and ensures that the only real dependency of CHAPERONg is simply a functional GROMACS installation. Thus, the entire MD simulation pipelines can be automatically executed without the need for installation of additional dependencies or software save those required by GROMACS itself.
Other modules of CHAPERONg which provide additional and advanced functionalities are written using Python. Various Python libraries are used including Numpy [20], Pandas and Scipy [21]; for data manipulation and numerical and scientific calculations, and Matplotlib [22]; for generating graphical plots and figures. PyMOL [23], ImageMagick, or ffmpeg is used for generating simulation movies. Secondary structure elements are analyzed using DSSP [24]. Xmgrace is used for graph plotting and conversion. The MD DaVis package [11] is used for the construction of hydrogen bond matrices and interactive three-dimensional visualizations of free energy landscapes. Installation of CHAPERONg is achieved by simply running the install script provided in the package. To make all features offered by CHAPERONg easily accessible to users, an isolated Anaconda Python environment with all needed dependencies can be set up by running a conda setup script also provided in the package.
CHAPERONg offers automated GROMACS-based workflows for unbiased conventional MD simulation of protein(-only) and protein complex systems, using established and previously reported protocols [25], [26]. In addition, up to 20 automated analysis types covering system setup and simulation quality assurance analyses as well as post-simulation trajectory analyses are provided. A GROMACS-based workflow for the steered MD and enhanced umbrella sampling simulations for protein complexes are also automated [27], [28], [25]. Automated quality assurance analyses and the WHAM (weighted histogram analysis method)-based free energy calculations [29], [30] are also provided for the biased simulations.
3. CHAPERONg features and functionalities
CHAPERONg can be run in one of two modes of automation depending on the user's choice; either as full-auto or semi-auto. In the full-auto mode, all simulation steps and post-simulation analyses are automatically carried out based on the simulation type and user-provided parameters. This greatly reduces repetitive and tedious manual interventions, and the user is only prompted for inputs in a very few exceptional cases where automatic or pre-defined choices might not be trivial or suitable (e.g. determining the box size of an umbrella sampling simulation). The semi-auto mode still has most of the simulation and analyses automated, but the user is prompted more for inputs and confirmation of automatically selected choices to give more flexibility and control over the simulation parameters.
3.1. Automated conventional MD simulation
CHAPERONg offers automated MD pipelines for various systems, namely protein-only (including protein-protein complexes), protein-ligand complexes, and protein-DNA complexes. For protein-ligand systems, the pipeline recognizes small molecule ligand topologies generated via popular ligand parameterization programs and webservers, including CGenFF (for CHARMM) [31], ACPYPE (for AMBER) [32], PRODRG2 (for GROMOS) [33], and LigParGen (for OPLS-AA) [34]. The automated protocol is organized into 12 major steps, enabling the user to start or resume from any step of the simulation process. The minimum input files required to run CHAPERONg are the starting structure and appropriate GROMACS parameter (.mdp) files.
3.1.1. System preparation and quality assurance analyses
Once launched, CHAPERONg automatically runs through the conversion of the input structure file to the GROMACS format, generation of protein topology (and ligand topology, if applicable), definition of the simulation box, addition of ions to the system, energy minimization and NVT/NPT equilibration steps. For each of these steps, the user has full control over how the system is set up. The system and topology files are automatically updated accordingly, depending on the type of system. Following the energy minimization and equilibration steps, quality assurance analyses–such as plots of the progression of the potential energy, density, temperature, pressure, and other thermodynamic parameters–are run. These enable the user to monitor the convergence of the indices and, hence, the quality of the simulation system.
3.1.2. MD simulation
Following a successful setup of the system, the production MD run proceeds for the duration specified by the user in the corresponding parameter file. CHAPERONg also offers the option to call GROMACS to extend a previously completed run, or to resume a terminated simulation. Similar to the system preparation stage, several quality assurance indices including some thermodynamic parameters are analyzed and produced as Xmgrace .xvg files as well as publication-quality .png figures.
3.2. Post-simulation processing and trajectory analyses
CHAPERONg provides the capability to carry out up to 20 post-simulation processing and trajectory analyses. These analyses, enabled by modules available in GROMACS, CHAPERONg, and other third-party tools, include root mean square deviation (RMSD), root mean square fluctuation (RMSF), radius of gyration (Rg), solvent accessible solvent area (SASA), hydrogen bond (Hbond) analysis, principal component analysis (PCA), secondary structure analysis, clustering analysis, simulation movie, two- and three-dimensional (visualizations of) free energy landscapes (FELs), kernel density estimation (KDE), interactive hydrogen bond matrix, MM-PBSA (Molecular mechanics Poisson–Boltzmann surface area) free energy calculations, and multiple quality assurance analyses. The plots from the analyses are generated as .xvg and publication-quality .png files. These analyses provide valuable computational metrics for characterizing the stability, folding, conformational changes, interactions and dynamics of biomolecules. For example, they help in the comparison of different MD simulation trajectories, analysis of the impact of mutations or ligand binding, and assessment of the accuracy of simulation models with respect to experimental data.
3.2.1. RMSD, RMSF, Rg and SASA
The RMSD, RMSF, and Rg are three important structural metrics used to characterize the MD simulation of biomolecular systems [35]. The RMSD, Rg, and RMSF are computed in GROMACS by the gmx rms, gmx gyrate, and gmx rmsf modules, respectively. RMSD measures the average distance between the atoms of a structure at an instant of the simulation against the reference starting structure. Thus, it is used to analyze the overall time-dependent structural deviation or similarity between the structures recorded in the trajectory [36], [37]. The RMSD plot of the simulated protein (and that of the ligand in the case of a protein-ligand complex) is generated as .xvg files and .png figures.
The RMSF, like the RMSD, is a common mobility measure that quantifies the local fluctuations or flexibility within a biomolecule during simulation by measuring the average atomic or residue-level deviations [36]. RMSF provides insights into the dynamic regions of proteins such as flexible loops, and can indicate the importance of specific residues in conformational changes or protein-ligand interactions [38]. Rg is a commonly used measure of the compactness of protein molecules, with smaller Rg values indicating a more compact or folded structure, and larger Rg values suggesting more extended or flexible conformations during the simulation [39].
SASA is a metric that provides information about the exposed surface area of a biomolecule that is accessible to the solvent molecules. It is commonly used to investigate protein folding and stability, as well as to characterize the interaction of a protein with the surrounding solvent [40]. SASA is computed in GROMACS by the gmx sasa module, which employs the double cubic lattice method [41]–a variant of the “rolling ball” algorithm of Shrake and Rupley [42]. Fig. 2 shows some examples of the automatically generated figures of the RMSD, RMSF, Rg, and SASA plots.
3.2.2. Hydrogen bonding analysis
Hydrogen bond (Hbond) analysis is often used in MD simulations of biomolecules for the investigation and understanding of protein structure, folding, function, and ligand binding as well as other biomolecular interactions [35]. Hbond calculation in GROMACS is carried out using the gmx hbond module. Depending on the type of system, the numbers of intra- and inter-molecular Hbonds are calculated and plotted as a function of simulation time. Several other output files, such as the Hbond matrix and index files, are also generated and processed by CHAPERONg to parse them as input to other analyses, like the MD Davis-based interactive Hbond matrix calculations.
3.2.3. Principal component analysis
Principal component analysis (PCA) is a statistical technique used to reduce the high-dimensional simulation data–i.e., the coordinates of atoms over time–into a smaller set of orthogonal (principal) components. It helps to visualize the essential dynamics and conformational changes in the trajectory by identifying the most important collective motions in the system [43]. PCA in GROMACS is carried out using the gmx covar and gmx anaeig modules. The principal components are also processed by CHAPERONg and parsed as input for further conformational analyses–e.g., as order parameters for constructing free energy landscapes.
3.2.4. Clustering analysis
Clustering in MD simulation is another common technique that is also used to reduce the complexity of trajectory data. It involves grouping similar conformations based on defined structural similarity, enabling the identification of dominant conformational states, dynamics, and transitions [44]. The gmx cluster module in GROMACS carries out the analysis, and the automation by CHAPERONg maintains the flexibility and array of options it offers. Fig. 3A shows examples of two of the output data plots generated by the analysis.
3.2.5. Secondary structure analysis
Secondary structure (SS) analysis of MD simulation trajectory involves identifying and quantifying the protein secondary structure elements throughout the simulation. The SS analysis in GROMACS is carried out by the gmx do_dssp module which relies on the DSSP program [24] for the assignment of SS elements. In addition to the SS analysis plot featuring the default seven SS types assigned by DSSP (see Fig. 3B, left), CHAPERONg reprocesses the SS elements matrix data to generate a second copy of the plot containing only the four basic SS elements—helices, beta-sheets, turns and coils–as shown in Fig. 3B (right). This simplifies the appearance of the plot to aid its visualization and analysis.
3.2.6. Simulation movie
An MD simulation can be summarized into a movie, which is a collection of frames extracted at a specified interval from the trajectory. Simulation movies facilitate the analysis, interpretation, and communication of the simulation results [45]. They provide an animated overview and visual representation of simulations, and can help to easily visualize the motions of regions of interest, such as active sites and pockets, or to observe conformational movements, interactions or displacement of ligands. The minimum requirement for CHAPERONg to create a simulation movie is PyMOL, a widely used molecular visualizer. CHAPERONg also utilizes either of the ImageMagick convert tool or ffmpeg (when either of them is detected on the user's machine) for improved movie quality. Supplementary Files S1 and S2 show two example movies generated by CHAPERONg for the example simulations of ubiquitin and ligand-bound KEAP1 Kelch domain, respectively.
3.2.7. Free energy landscapes
Free energy landscapes (FELs) provide insights into the energetics and stability of different conformational states in MD simulation trajectories. CHAPERONg offers three alternative automated ways for the construction of two-dimensional representations of the FEL (Fig. 4). These are enabled by the GROMACS gmx sham module for 2D visualizations (Fig. 4A), the CHAPERONg energetic landscape module for enhanced 2D visualizations (Fig. 4B), and the MD DaVis tool for interactive 3D visualizations (Fig. 4C). Each of these alternatives requires the user to specify two order parameters for the FEL calculations. Global parameters that describe the state of the system can be used as input, including RMSD, Rg, principal components, fraction of native contacts or number of Hbonds, backbone dihedral angles and configurational distance, etc. [46]. Two preset pairs of order parameters–principal components from a PCA run and the RMSD-Rg pair–are available in CHAPERONg. A third option that allows the user to provide other quantities of interest as input is also available.
The FEL calculation by CHAPERONg employs a modified version of a previously described method [46], [47]. The relative free energies of states are estimated using Boltzmann inversion as shown in Equation (1). The relative free energy of the most probable state is set to zero while other states are computed to have more positive relative free energies. For all the three approaches, CHAPERONg also automates the extraction of the lowest energy structures from the FELs, as well as other FEL-guided structures or frames specified by the user.
(1) |
where k is the Boltzmann constant, T is the simulation temperature, is the probability of the system being in a particular state i characterized by some reaction coordinate r (quantities of interest) and is obtained from a histogram of the MD data, is the probability of the most populated bin (i.e., most probable state), and is the free energy change of the state i.
3.2.8. Kernel density estimation
Kernel density estimation (KDE) is a non-parametric technique used to estimate the probability density function (PDF) of a given dataset. This technique utilizes a smooth function, using the Numpy and Scipy Python libraries, CHAPERONthe kernel, centered at sampled datapoints or bins. The Gaussian kernel is one of the commonly used kernels. Given a sample with an unknown density f at any given point x. The kernel density estimator of the shape of the function f is defined as shown in Equation (2).
(2) |
where K is the kernel (a simple non-negative function such as the Gaussian distribution), and is the smoothing bandwidth.
Using the Numpy and Scipy Python libraries, CHAPERONg automates the kernel density estimation of the PDF for four common MD trajectory data types, including RMSD, Rg, Hbond, and SASA. This estimation can be carried out for single dataset KDE plots (Fig. 5A) as well as for comparative multiple datasets plots (Fig. 5B). The plots are generated as .xvg and high-quality .png files. Depending on the user's choice, CHAPERONg offers automatic and custom selection of the type of bin size estimator, optimal number of histogram bins, and the smoothing bandwidth. The KDE analysis presents a means to gaining further insights into MD simulation trajectories. For instance, the SASA KDE plots shown in Fig. 5 provide a different perspective towards the understanding of the SASA data other than the time-dependent information provided in Fig. 2D.
3.2.9. Interactive hydrogen bond matrix
CHAPERONg automates the integration of the MD DaVis tool with GROMACS for the construction of a Hbond matrix. To achieve this, CHAPERONg prepares a reference (the first structure from the trajectory) and the Hbond list (from the Hbond index file produced by gmx hbond). These files are then parsed as input to MD DaVis to produce an interactive .html plot (Fig. 6) that gives detailed information about the Hbond contacts recorded in the trajectory [11].
3.2.10. Binding free energy calculations using g_mmpbsa
The g_mmpbsa [48] is a widely used tool that integrates MD simulation with MM-PBSA binding free energy calculation for protein complexes. It also carries out the decomposition of the calculated free energies into contributions per residue [48]. CHAPERONg automates and streamlines the workflow for these calculations. Since the original g_mmpbsa is only compatible with GROMACS versions 5.x (or lower) and does not support the more recent and upgraded versions, it has become a common practice for users to install the older GROMACS version as a second copy for use by g_mmpbsa. Thus, the user would need to provide CHAPERONg with the path to the appropriate gmx executable. However, the g_mmpbsa code has recently been updated by other people [49] and is supposed to support newer GROMACS versions. In this case, there would be no need to specify any path and CHAPERONg would automatically call the active GROMACS.
3.2.11. Averaged plot of replica analysis plots
It is a common practice to conduct replica MD simulations of a system, yielding multiple independent trajectories with a higher probability of a wider sampling of the conformational space. Typically, the analysis of the simulations is carried out as means of the replica runs to obtain statistically reliable data, ensure reproducibility, and provide error estimates [50]. CHAPERONg offers a way to automatically generate averaged plots of multiple replica analysis plots, such as the replica plots of the RMSD, Rg, RMSF, SASA, number of hydrogen bonds, or some other user-provided replica plots.
3.3. Steered MD and umbrella sampling simulations
The steered MD-umbrella sampling simulation workflow is a powerful technique for estimating the free energy of binding for protein complexes [51], [27], [52], and for studying ligand unbinding pathways [28], [53]. This involves a pulling simulation driven by a biasing potential along a given reaction coordinate (Fig. 7). Umbrella sampling simulations are then carried out on a series of configurations in different sampling windows (Fig. 8A). A technique such as the WHAM is finally used to de-bias the system, calculate the potential of mean force (PMF), and consequently, estimate the free energy of binding (Fig. 8B). This entire workflow is streamlined and automated by CHAPERONg as briefly described below.
3.3.1. System preparation
Depending on the type of system being simulated, the protein and ligand topologies are generated. Then, a placeholder cubic unit cell is generated and the user is interactively guided to adjust the box and center-of-mass dimensions in an iterative visualize-and-adjust manner (using a molecular visualizer such as PyMOL). This is followed by the solvation, ion adding, energy minimization, and equilibration steps. Several system setup quality assurance analyses are then carried out.
3.3.2. Steered MD simulation and movie
Steered MD simulation involves the pulling apart of the defined pulled and reference groups (illustrated in Fig. 7A). Examples of some of the output files are shown in Fig. 6, including plots of each of the displacement of the pulled group and the pull force against time (Figs. 7B and 7C) and a plot of the pull force against the displacement (Fig. 7D). In addition, a movie of the pulling simulation is also generated. Supplementary File S3 and Supplementary File S4 show example movies for protein-protein and protein-ligand steered MD simulations, respectively. Using the PyMOL interface, the user can customize the renderings in the movie, and then re-run CHAPERONg to effect the modifications.
3.3.3. Umbrella sampling
Coordinates are extracted from the steered MD trajectory and the COM distance for each frame is calculated using the gmx distance module. Based on user-specified spacing, CHAPERONg further uses the distances to identify the starting configurations for the umbrella sampling simulations. Umbrella sampling is then iteratively run for each sampling window.
3.3.4. Potential of mean force and binding energy calculation
Using the WHAM calculations via the gmx wham module, the output files from the umbrella sampling simulations are used to compute the PMF and, consequently, the free energy of binding. The plots of the umbrella sampling histograms (Fig. 8A) and the PMF curve (Fig. 8B) are generated as .png and .xvg files. Also, the binding free energy is calculated and written to a summary file. In a situation where there are windows with insufficient sampling, CHAPERONg also offers the possibility to run umbrella sampling for additional user-defined windows.
4. Example test cases
Four detailed tutorials using example test cases are available online at dedicated web pages accessible via https://abeebyekeen.com/chaperong-online-tutorials. These include individual tutorials for:
-
1.
Protein-only systems MD simulation.
-
2.
Protein-ligand complex MD simulation.
-
3.
Protein-ligand Umbrella sampling simulation.
In addition, two studies that utilized CHAPERONg have recently been published [54], [55] while this article was under review. These works demonstrate the application of CHAPERONg for GROMACS MD simulations in drug discovery projects.
5. Conclusions
In this work, we have developed CHAPERONg, an easy-to-use open-source software that automates the GROMACS MD simulation pipelines for conventional unbiased MD, steered MD, and enhanced umbrella sampling simulations for diverse biomolecular systems. It also offers automated extensive system setup, post-simulation quality assurance analyses, and comprehensive trajectory analyses. Thus, CHAPERONg makes MD simulation more accessible to users who have limited experience working with the command line or lack programming skills. It also enables users to gain more insights into MD simulation data by providing an interface that overcomes the technical barriers to processing and analyzing trajectory data. We aim to continuously enhance the usability of CHAPERONg based on users' feedback. Future updates would include additional functionalities to expand the capabilities of the software.
Declaration of Competing Interest
Authors declare no competing interest.
Footnotes
Supplementary material related to this article can be found online at https://doi.org/10.1016/j.csbj.2023.09.024.
Contributor Information
Abeeb Abiodun Yekeen, Email: yekeenaa@mail.ustc.edu.cn.
Rotimi Olusanya Arise, Email: arise.ro@unilorin.edu.ng.
Appendix A. Supplementary material
The following is the Supplementary material related to this article.
Data availability
The CHAPERONg code can be downloaded at https://github.com/abeebyekeen/CHAPERONg. Extensive documentation and detailed tutorials are available online at https://abeebyekeen.com/chaperong-online.
References
- 1.Karplus M., McCammon J.A. Molecular dynamics simulations of biomolecules. Nat Struct Biol. 2002;9(9):646–652. doi: 10.1038/nsb0902-646. [DOI] [PubMed] [Google Scholar]
- 2.Hollingsworth S.A., Dror R.O. Molecular dynamics simulation for all. Neuron. 2018;99(6):1129–1143. doi: 10.1016/j.neuron.2018.08.011. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3.Hospital A., Goñi J.R., Orozco M., Gelpí J.L. Molecular dynamics simulations: advances and applications. Adv Appl Bioinform Chem. 2015:37–47. doi: 10.2147/AABC.S70333. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.Van Der Spoel D., Lindahl E., Hess B., Groenhof G., Mark A.E., Berendsen H.J. GROMACS: fast, flexible, and free. J Comput Chem. 2005;26(16):1701–1718. doi: 10.1002/jcc.20291. [DOI] [PubMed] [Google Scholar]
- 5.Makarewicz T., Kaźmierkiewicz R. Molecular dynamics simulation by GROMACS using GUI plugin for PyMOL. J Chem Inf Model. 2013;53(5):1229. doi: 10.1021/ci400071x. [DOI] [PubMed] [Google Scholar]
- 6.Sarkar A., Santoro J., Di Biasi L., Marrafino F., Piotto S. YAMACS: a graphical interface for GROMACS. Bioinformatics. 2022;38(19):4645–4646. doi: 10.1093/bioinformatics/btac573. [DOI] [PubMed] [Google Scholar]
- 7.Liu H., Jin Y., Ding H. MDBuilder: a PyMOL plugin for the preparation of molecular dynamics simulations. Brief Bioinform. 2023;24(2) doi: 10.1093/bib/bbad057. [DOI] [PubMed] [Google Scholar]
- 8.Vieira I.H.P., Botelho E.B., de Souza Gomes T.J., Kist R., Caceres R.A., Zanchi F.B. Visual dynamics: a web application for molecular dynamics simulation using GROMACS. BMC Bioinform. 2023;24(1):1–8. doi: 10.1186/s12859-023-05234-y. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Bayarri G., Andrio P., Hospital A., Orozco M., Gelpí J.L. BioExcel Building Blocks Workflows (BioBB-Wfs), an integrated web-based platform for biomolecular simulations. Nucleic Acids Res. 2022;50(W1):W99–W107. doi: 10.1093/nar/gkac380. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Kagami L.P., das Neves G.M., Timmers L.F.S.M., Caceres R.A., Eifler-Lima V.L. Geo-Measures: a PyMOL plugin for protein structure ensembles analysis. Comput Biol Chem. 2020;87 doi: 10.1016/j.compbiolchem.2020.107322. [DOI] [PubMed] [Google Scholar]
- 11.Maity D., Pal D. MD DaVis:: interactive data visualization of protein molecular dynamics. Bioinformatics. 2022;38(12):3299–3301. doi: 10.1093/bioinformatics/btac314. [DOI] [PubMed] [Google Scholar]
- 12.Kota P. GUIMACS-a Java based front end for GROMACS. In Silico Biol. 2007;7(1):95. [PubMed] [Google Scholar]
- 13.Roopra S., Knapp B., Omasits U., Schreiner W. jSimMacs for GROMACS: a Java application for advanced molecular dynamics simulations with remote access capability. J Chem Inf Model. 2009;49(10):2412–2417. doi: 10.1021/ci900248f. [DOI] [PubMed] [Google Scholar]
- 14.Sellis D., Vlachakis D., Vlassi M. Gromita: a fully integrated graphical user interface to gromacs 4. Bioinform Biol Insights. 2009;3:99–102. doi: 10.4137/bbi.s3207. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Makarewicz T., Kaźmierkiewicz R. Improvements in GROMACS plugin for PyMOL including implicit solvent simulations and displaying results of pca analysis. J Mol Model. 2016;22(109):1–7. doi: 10.1007/s00894-016-2982-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Zinovjev K., Van Der Kamp M.W. Enlighten2: molecular dynamics simulations of protein-ligand systems made accessible. Bioinformatics. 2020;36(20):5104–5106. doi: 10.1093/bioinformatics/btaa643. [DOI] [PubMed] [Google Scholar]
- 17.Hospital A., Andrio P., Fenollosa C., Cicin-Sain D., Orozco M., Gelpí J.L. MDWeb and MDMoby: an integrated web-based platform for molecular dynamics simulations. Bioinformatics. 2012;28(9):1278–1279. doi: 10.1093/bioinformatics/bts139. [DOI] [PubMed] [Google Scholar]
- 18.https://simlab.uams.edu/ WebGRO for macromolecular simulations. University of Arkansas for Medical Sciences. Available from.
- 19.Jo S., Kim T., Iyer V.G., Im W. CHARMM-GUI: a web-based graphical user interface for CHARMM. J Comput Chem. 2008;29(11):1859–1865. doi: 10.1002/jcc.20945. [DOI] [PubMed] [Google Scholar]
- 20.Harris C.R., Millman K.J., Van Der Walt S.J., Gommers R., Virtanen P., Cournapeau D., et al. Array programming with NumPy. Nature. 2020;585(7825):357–362. doi: 10.1038/s41586-020-2649-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21.Virtanen P., Gommers R., Oliphant T.E., Haberland M., Reddy T., Cournapeau D., et al. Scipy 1.0: fundamental algorithms for scientific computing in python. Nat Methods. 2020;17(3):261–272. doi: 10.1038/s41592-019-0686-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22.Hunter J.D. Matplotlib: a 2D graphics environment. Comput Sci Eng. 2007;9(3):90–95. [Google Scholar]
- 23.DeLano W.L. The PyMOL molecular graphics system. 2002. http://www.pymol.org/
- 24.Kabsch W., Sander C. Dictionary of protein secondary structure: pattern recognition of hydrogen-bonded and geometrical features. Biopolymers. 1983;22(12):2577–2637. doi: 10.1002/bip.360221211. [DOI] [PubMed] [Google Scholar]
- 25.Lemkul J.A. From proteins to perturbed Hamiltonians: a suite of tutorials for the GROMACS-2018 molecular simulation package [article v1.0] LiveCoMS. 2018;1(1):5068. [Google Scholar]
- 26.Sedzro D.M., Idris M.O., Durojaye O.A., Yekeen A.A., Fadahunsi A.A., Alakanse S.O. Identifying potential p53-MDM2 interaction antagonists: an integrated approach of pharmacophore-based virtual screening, interaction fingerprinting, MD simulation and DFT studies. ChemistrySelect. 2022;7(39) [Google Scholar]
- 27.Lemkul J.A., Bevan D.R. Assessing the stability of Alzheimer's amyloid protofibrils using molecular dynamics. J Phys Chem B. 2010;114(4):1652–1660. doi: 10.1021/jp9110794. [DOI] [PubMed] [Google Scholar]
- 28.Sun H., Tian S., Zhou S., Li Y., Li D., Xu L., et al. Revealing the favorable dissociation pathway of type ii kinase inhibitors via enhanced sampling simulations and two-end-state calculations. Sci Rep. 2015;5(1):8457. doi: 10.1038/srep08457. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 29.Kumar S., Rosenberg J.M., Bouzida D., Swendsen R.H., Kollman P.A. The weighted histogram analysis method for free-energy calculations on biomolecules. I. The method. J Comput Chem. 1992;13(8):1011–1021. [Google Scholar]
- 30.Souaille M., Roux B. Extension to the weighted histogram analysis method: combining umbrella sampling with free energy calculations. Comput Phys Commun. 2001;135(1):40–57. [Google Scholar]
- 31.Vanommeslaeghe K., Hatcher E., Acharya C., Kundu S., Zhong S., Shim J., et al. CHARMM general force field: a force field for drug-like molecules compatible with the CHARMM all-atom additive biological force fields. J Comput Chem. 2010;31(4):671–690. doi: 10.1002/jcc.21367. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 32.Sousa da Silva A.W., Vranken W.F. ACPYPE–antechamber python parser interface. BMC Res Notes. 2012;5(367) doi: 10.1186/1756-0500-5-367. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 33.Van Aalten D.M., Bywater R., Findlay J.B., Hendlich M., Hooft R.W., Vriend G. PRODRG, a program for generating molecular topologies and unique molecular descriptors from coordinates of small molecules. J Comput-Aided Mol Des. 1996;10:255–262. doi: 10.1007/BF00355047. [DOI] [PubMed] [Google Scholar]
- 34.Dodda L.S., Cabeza de Vaca I., Tirado-Rives J., Jorgensen W.L. LigParGen web server: an automatic OPLS-AA parameter generator for organic ligands. Nucleic Acids Res. 2017;45(W1):W331–W336. doi: 10.1093/nar/gkx312. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 35.Ishak S.N.H., Aris S.N.A.M., Halim K.B.A., Ali M.S.M., Leow T.C., Kamarudin N.H.A., et al. Molecular dynamic simulation of space and earth-grown crystal structures of thermostable T1 lipase Geobacillus zalihae revealed a better structure. Molecules. 2017;22(10):1574. doi: 10.3390/molecules22101574. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 36.Martínez L. Automatic identification of mobile and rigid substructures in molecular dynamics simulations and fractional structural fluctuation analysis. PLoS ONE. 2015;10(3) doi: 10.1371/journal.pone.0119264. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 37.Sargsyan K., Grauffel C., Lim C. How molecular size impacts RMSD applications in molecular dynamics simulations. J Chem Theory Comput. 2017;13(4):1518. doi: 10.1021/acs.jctc.7b00028. [DOI] [PubMed] [Google Scholar]
- 38.Idris M.O., Yekeen A.A., Alakanse O.S., Durojaye O.A. Computer-aided screening for potential TMPRSS2 inhibitors: a combination of pharmacophore modeling, molecular docking and molecular dynamics simulation approaches. J Biomol Struct Dyn. 2021;39(15):5638–5656. doi: 10.1080/07391102.2020.1792346. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 39.Lobanov M.Y., Bogatyreva N., Galzitskaya O. Radius of gyration as an indicator of protein structure compactness. Mol Biol. 2008;42:623–628. [PubMed] [Google Scholar]
- 40.Savojardo C., Manfredi M., Martelli P.L., Casadio R. Solvent accessibility of residues undergoing pathogenic variations in humans: from protein structures to protein sequences. Front Mol Biosci. 2021;7(626363) doi: 10.3389/fmolb.2020.626363. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 41.Eisenhaber F., Lijnzaad P., Argos P., Sander C., Scharf M. The double cubic lattice method: efficient approaches to numerical integration of surface area and volume and to dot surface contouring of molecular assemblies. J Comput Chem. 1995;16(3):273–284. [Google Scholar]
- 42.Shrake A., Rupley J.A. Environment and exposure to solvent of protein atoms. Lysozyme and insulin. J Mol Biol. 1973;79(2):351–371. doi: 10.1016/0022-2836(73)90011-9. [DOI] [PubMed] [Google Scholar]
- 43.David C.C., Jacobs D.J. Humana Press; Totowa, NJ: 2014. Principal component analysis: a method for determining the essential dynamics of proteins; pp. 193–226. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 44.Phillips J.L., Colvin M.E., Newsam S. Validating clustering of molecular dynamics simulations using polymer models. BMC Bioinform. 2011;12(1):1–23. doi: 10.1186/1471-2105-12-445. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 45.Lindahl E. Springer New York; New York, NY: 2015. Molecular dynamics simulations; pp. 3–26. [Google Scholar]
- 46.Tavernelli I., Cotesta S., Di Iorio E.E. Protein dynamics, thermal stability, and free-energy landscapes: a molecular dynamics investigation. Biophys J. 2003;85(4):2641–2649. doi: 10.1016/s0006-3495(03)74687-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 47.Papaleo E., Mereghetti P., Fantucci P., Grandori R., De Gioia L. Free-energy landscape, principal component analysis, and structural clustering to identify representative conformations from molecular dynamics simulations: the myoglobin case. J Mol Graph Model. 2009;27(8):889–899. doi: 10.1016/j.jmgm.2009.01.006. [DOI] [PubMed] [Google Scholar]
- 48.Kumari R., Kumar R., Consortium O.S.D.D., Lynn A. g_mmpbsa–a GROMACS tool for high-throughput MM-PBSA calculations. J Chem Inf Model. 2014;54(7):1951–1962. doi: 10.1021/ci500020m. [DOI] [PubMed] [Google Scholar]
- 49.https://github.com/tildeslu/g_mmpbsa g_mmpbsa (modified). Available from.
- 50.Knapp B., Ospina L., Deane C.M. Avoiding false positive conclusions in molecular simulation: the importance of replicas. J Chem Theory Comput. 2018;14(12):6127–6138. doi: 10.1021/acs.jctc.8b00391. [DOI] [PubMed] [Google Scholar]
- 51.Grupp B., Lemkul J.A., Gronemeyer T. An in silico approach to determine inter-subunit affinities in human septin complexes. Cytoskeleton. 2023 doi: 10.1002/cm.21749. [DOI] [PubMed] [Google Scholar]
- 52.Ngo S.T., Vu K.B., Bui L.M., Vu V.V. Effective estimation of ligand-binding affinity using biased sampling method. ACS Omega. 2019;4(2):3887–3893. doi: 10.1021/acsomega.8b03258. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 53.Tam N.M., Nguyen T.H., Ngan V.T., Tung N.T., Ngo S.T. Unbinding ligands from SARS-CoV-2 Mpro via umbrella sampling simulations. R Soc Open Sci. 2022;9(1) doi: 10.1098/rsos.211480. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 54.Durojaye O.A., Ejaz U., Uzoeto H.O., Fadahunsi A.A., Opabunmi A.O., Ekpo D.E., et al. Csc01 shows promise as a potential inhibitor of the oncogenic G13D mutant of KRAS: an in silico approach. Amino Acids. 2023:1–20. doi: 10.1007/s00726-023-03304-2. [DOI] [PubMed] [Google Scholar]
- 55.Durojaye O.A. Delineation of the CENP-LN sub-complex dissociation mechanism upon multisite phosphorylation during mitosis. J Biomol Struct Dyn. 2023:1–19. doi: 10.1080/07391102.2023.2249101. [DOI] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
The CHAPERONg code can be downloaded at https://github.com/abeebyekeen/CHAPERONg. Extensive documentation and detailed tutorials are available online at https://abeebyekeen.com/chaperong-online.