Skip to main content
Biophysical Journal logoLink to Biophysical Journal
. 2018 Mar 27;114(6):1267–1273. doi: 10.1016/j.bpj.2018.01.033

CONAN: A Tool to Decode Dynamical Information from Molecular Interaction Maps

Davide Mercadante 1, Frauke Gräter 1,2, Csaba Daday 1,2,
PMCID: PMC5883949  PMID: 29590584

Abstract

The analysis of contacts is a powerful tool to understand biomolecular function in a series of contexts, from the investigation of dynamical behavior at equilibrium to the study of nonequilibrium dynamics in which the system moves between multiple states. We thus propose a tool called CONtact ANalysis (CONAN) that, from molecular dynamics (MD) trajectories, analyzes interresidue contacts, creates videos of time-resolved contact maps, and performs correlation, principal component, and cluster analysis, revealing how specific contacts relate to functionally relevant states sampled by MD. We present how CONAN can identify features describing the dynamics of ubiquitin both at equilibrium and during mechanical unfolding. Additionally, we show the analysis of MD trajectories of an α-synuclein mutant peptide that undergoes an α-β conformational transition that can be easily monitored using CONAN, which identifies the multiple states that the peptide explores along its conformational dynamics. The high versatility and ease of use of the software make CONAN a tool that can significantly facilitate the understanding of the complex dynamical behavior of proteins or other biomolecules. CONAN and its documentation are freely available for download on GitHub.

Introduction

Protein dynamics critically determine biological function. Given how complex and nonisotropic proteins are, describing their dynamics is a challenging task. Contact maps represent a formidable instrument for depicting intramolecular or intermolecular interactions. By definition, they are two-dimensional (2D) matrices that are built employing a user-defined cutoff on the basis of a chosen interresidue distance criterion relevant to the investigated molecular behavior (1). They have been used to predict and describe the formation of protein complexes (2), to reconstruct the three-dimensional (3D) structure of proteins (3), in protein folding studies (4), or, more recently, as a base of Markov-state models for protein folding (5).

Contact maps encode all the structural information (secondary and tertiary structure) characterizing the investigated molecule. Helices can be identified by a thickening of the matrix diagonal, whereas parallel and antiparallel β-strands are represented as narrow contact stretches orthogonal or parallel to the diagonal of the matrix, respectively, and similar patterns can show parallel and antiparallel packing in general. Thus, contact maps encode structural information through an exhaustive 2D representation of distances.

However, molecular simulations additionally sample conformational properties of molecules through time. The incorporation of dynamical information in contact matrices is extremely valuable to describe structural changes observed along a trajectory. At equilibrium, the analysis of contacts along MD trajectories can be useful to understand the lifetime of contacts across the structure, the achievement of convergence, or new conformational states explored by a system (6, 7). Contact maps can also reveal information about the stability of intramolecular interactions during unfolding of the protein, as for example in force-probe molecular dynamics simulations (8). In these nonequilibrium conditions, the time-resolved analysis of contact maps can show the order in which contacts break along the pulling trajectory, which interactions are mostly responsible for withstanding the applied force, can identify unfolding intermediates, and whether there are multiple unfolding pathways.

Several tools have been created to visualize contact matrices and map the information they carry onto the 3D structure of molecules (3, 9, 10, 11, 12), but they mostly focus on encoding static (structural) information in them or require substantial input from the user. We here present a tool named CONtact ANalysis (CONAN) that, in addition to generating time-averaged quantities, also captures and encodes dynamical information from molecular dynamics (MD) trajectories into contact maps in a highly automated manner, requiring no scripting experience on the part of the user.

CONAN automatically generates publication-quality images and videos showing the evolution of contacts along MD trajectories and additionally provides a series of statistical analysis correlating the formation and rupture of contacts with time or with any observable of interest. It also implements contact map-based alternatives to commonly used techniques in computational biophysics, such as root-mean-square deviation (RMSD) and root-mean-square fluctuations (RMSFs), cluster analysis (in particular, hierarchical clustering (13)), and principal component analysis (PCA) (similar to (14)), thus offering the inherent advantage of avoiding the fitting procedure and/or the use of average coordinates required to perform these analyses based on atomic positions. CONAN also introduces an interresidue cross correlation based on the number of contacts rather than molecular fluctuations, again eschewing any interframe fitting.

We here report the analysis of test cases in which force-probe and equilibrium MD runs are performed on ubiquitin (15) and on a mutant peptide of α-synuclein (16), respectively. In addition, we illustrate how CONAN can also analyze protein-protein interactions by classifying villin headpiece homodimers (17) (Supporting Material). These test systems demonstrate the capabilities of CONAN in identifying conformational transitions. We show how the presented tool is helpful in the detailed description of an unfolding pathway of ubiquitin. The simulated α-synuclein fragment, on the other hand, undergoes an α to β transition that can be readily identified by CONAN. Contact maps colored by the chemical nature of the most long-lived interactions allow the straightforward identification of the chemical moieties playing a predominant role in the observed transition. Overall, the set of features comprised in CONAN make it a powerful tool for the analysis of MD simulations.

Methods

We here restrict our discussion to the definition and choice of cutoffs. See Supporting Material and the online manual for a full explanation of possible outputs and methods.

Definition of contacts

CONAN can be customized with up to three different cutoff distances:

  • rcut This is the main cutoff value. Any residue pair without any atoms within this cutoff is disregarded.

  • rinter This is the cutoff value under which interactions are formed.

  • rinterhigh This is the cutoff value over which interactions are broken.

The main quantity CONAN uses is the interresidue distance defined as:

rij(t)={rijmin(t)rijmin<rcutrcutrijminrcut,

where rijmin(t) is the minimum distance between atoms from residues i and j. The user can choose a given class of atoms of interest (Cα, backbone atoms, side chains, any heavy atoms, any atom, etc.). In the analysis presented below, we always consider only heavy atom distances, as it reduces the search space by a factor of ∼4 without losing significant information, a main cutoff rcut=1 nm, and interactions defined using the same cutoff, rinter=rinterhigh=0.5 nm. The approach of using two different cutoffs for breaking and forming interactions, proposed before by Best et al. (18), avoids the underestimation of the stability of interactions due to a few outlier frames. However, in this case, we are using only one value for simplicity.

Functionality of CONAN

CONAN has been designed with the purpose of being both user-friendly and versatile and requires few extra packages installed. To run the contact-based analysis of the performed MD simulations, the user provides a single input file with a set of keywords that the software interprets to perform the desired analyses. The input files used in the example cases used here are in the Supporting Material. To build contact maps, CONAN utilizes the mdmat utility provided in the GROMACS MD simulation engine (19) and interprets the output to retrieve the required statistics (Fig. 1). Using gmx mdmat has the inherent advantage of being compatible with other GROMACS tools (for example, using the custom index files). We stress, however, that a series of tools are available to convert trajectories to GROMACS format, and therefore CONAN is also compatible with results obtained from other packages. In the Supporting Material, we illustrate this by analyzing a trajectory obtained from CHARMM (Accelrys, San Diego, CA).

Figure 1.

Figure 1

Flowchart illustrating CONAN’s main workflow. The flowchart shows the different tools (left-hand side of the figure) used by CONAN to output a series of analysis required by the user (right-hand side of the figure). The kinds of analysis to perform, as well as the corresponding parameters, are defined in the CONAN input file. All of the plots except this figure and Fig. 4A are based on standard outputs from CONAN, augmented mainly only by 3D structures and highlights. obs., observation. To see this figure in color, go online.

CONAN is programmed in Python 3 and is therefore easily available as a package as well. Given the possibly costly memory requirements of Nres2×Nframes (number of residues squared times number of frames), we took particular care of economical data storage. All of the memory-sensitive quantities are stored in a sparse way and using half-precision (numpy’s float16 structure) for efficient memory use. Furthermore, CONAN can be run in an “economy mode” in which only one frame and only aggregate quantities are stored, thereby reducing the memory usage to a minimum. Analogously, since the plain-text matrices can occupy significant disk space, the user also has an option to only store aggregate ones and/or only the .png files. Further information on requirements can be found in the manual. The current main bottleneck is generating the framewise .png files in gnuplot, and the CONAN-specific commands are executed very efficiently through vectorized instructions implemented in numpy and scipy. For example, turning off .png generation, the given example of ubiquitin unfolding, involving 1976 pairs and 2357 frames, requires ∼33 s on a single core of an Intel i7-4770 (Intel, Santa Clara, CA) central processing unit for a standard analysis, and 84 s for a full analysis (correlations, both types of cluster analysis, and PCA); in fact, even these timings are mostly input/output-limited.

CONAN uses gnuplot (20) to plot at each time step the interaction maps calculated from the contact matrix and collates them using video encoding (×264 in this case) for the creation of videos that show time-resolved evolution of the contacts. As color schemes for the creation of contact maps, we use cubehelix (21) for distances and times (sequential data) and an 11-class version of Cynthia Brewer’s PuOr (purple-orange) scheme (22) for divergent data (changes or correlation coefficients), in which we set the central point to be exactly white (#FFFFFF in hexadecimal). CONAN, its documentation, and example use cases are freely available for download at https://github.com/HITS-MBM/conan under GPL 3.0. Further examples and explanations can be found on http://contactmaps.blogspot.com.

Results and Discussion

Ubiquitin equilibrium dynamics analyzed with CONAN

Ubiquitin is a small molecule structurally characterized by different secondary structure elements (one α-helix and a four strands β-sheet), and a useful model system for computational and experimental studies investigating protein structural and dynamical behavior: from the investigation of protein folding (23) to the testing of protein force fields used in MD simulations (24). We have herein chosen this molecule to provide a test case representing the capabilities of CONAN and therefore have performed equilibrium and force-probe MD simulations to illustrate how contact map analysis, as provided by CONAN, can lead to a deep understanding of protein functional dynamics.

At equilibrium, we computed the average contact map of the protein (Fig. 2 C), which clearly shows that the protein’s secondary structure is stable, with the α1 helix, the antiparallel packing between strands β1-β2, β3-β4, and the parallel packing between strands β2-β3 and between β1-β4. Furthermore, we can also observe fluctuations between interresidue distances (Fig. 2 D), which are dominated by the motion of the C-terminal linker with respect to the β3 strand and its immediate vicinity. RMSFs (Fig. 2 B) are a widely used observable to monitor, on average, the dynamics of residues within a structure. CONAN’s interresidue distance fluctuations can be considered as more reliable than RMSF values, especially when large fluctuations occur, as average positions can be physically meaningless. Furthermore, the output contains the most relevant interactions (changing only within values lower than the main cutoff) rather than identifying single residues.

Figure 2.

Figure 2

Dynamics of ubiquitin at equilibrium investigated by contact maps. (A) The structure of a ubiquitin molecule in a cartoon representation and colored according to its secondary structure elements and numbers denoting the most important groups of contacts are shown. (B) 3D coordinates-based root mean-square fluctuations (RMSFs) of ubiquitin are shown. (C) The average contact map is shown, with circles highlighting the most important contacts. (D) A symmetric contact map showing the standard deviation of contact distances along the trajectory. To see this figure in color, go online.

The correlation of interresidue contacts with time shows a significant conformational rearrangement of the protein (Fig. 3 A). In particular, residue K48 drifts and increases its distance from residues I42 and R44 and approaches residue D58 with which it establishes a stable salt bridge. The salt bridge network newly formed between D51, R54, D58, and K48 is responsible for this stable conformation observed at the end of the simulated trajectory and representing a stable conformational state of the protein (Fig. 3). The correlation map clearly pinpoints the relevant regions in the 3D overlap of structures (Fig. 3 A). The conformational rearrangement is also captured in the interresidue cross correlation, which identifies a competitive behavior between R42 and D58 (see Fig. S1 and further explanation there).

Figure 3.

Figure 3

Correlation of interresidue distance with time. (A) An ensemble of ubiquitin at the equilibrium is shown. The conformers shown have been collected at every 5 ns and are colored as a function of time from red (start of the simulation) to blue (end of the simulation). The residues involved in pairs showing the highest correlations with time in map (B) are shown in licorice. (B) Correlation of interresidue distances with time are shown. Negative Pearson coefficients (orange) correspond to contact formation and positive ones (purple) correspond to contact ruptures. We highlight the largest changes in blue (ruptures) and pink (formations) in both plots.

This kind of analysis can be useful to diagnose drifts from the starting structure (for example, a crystal structure or a homology model), which might also reflect a lack of convergence in the simulation: in the (usually not achievable) limit of full exploration of the phase space, none of the interresidue or interdomain distances would show a significant correlation with time. In this case, a relatively short simulation time (50 ns) has been chosen, as can be seen by the significant time correlations identified. CONAN interestingly resolves a “local drift,” with some regions equilibrated and others still changing conformation; this would be quite difficult to define in terms of 3D coordinates.

As mentioned in the Methods, CONAN can also identify the sequence determinants of macroscopic quantities; we show how certain loop rearrangements explain changes in radius of gyration Rg in Fig. S2.

Unfolding trajectory of ubiquitin

Beyond studying the behavior of molecules at equilibrium, nonequilibrium trajectories can also be analyzed by looking at the formation or rupture of contacts. In this case, we show how the unfolding of ubiquitin, triggered by the application of an external force, can be mapped onto the protein’s structure through the use of CONAN.

Fig. 4 B reports the last encounter of residue pairs (i.e., unfolding times) and shows how these events are clearly clustered around two moments. First, around 40 ns (faint gray), β1 loses contact with β4 and β2. Then, around 100 ns (pink-orange), α1 and β3β4 lose contact with each other. Both of these events coincide with a drop in force (at 40 and 100 ns), reflecting barrier crossing events (Fig. 4 A). Finally, at various points in time after ∼150 ns (green or darker), α1 and various small helical regions lose contact as the peptide becomes straighter. This last part of the unfolding happens without any resistance; therefore, the events happen without any cooperativity. The above-described pathway is in close agreement with previous MD studies of ubiquitin under force (25). Fig. S4 contains the differential contact maps of the four stages. Finally, the different domains of the ubiquitin unfolding can also be detected by residue clustering, clearly distinguishing the two β-strands from the other residues (see Fig. S5).

Figure 4.

Figure 4

Force-driven unfolding of ubiquitin. (A) A force profile as a function of time is shown. (B) A time-encoded contact map showing the times of contact breaking is shown. The color code of subplot (B) is repeated in (A) for ease of comparison. To see this figure in color, go online.

In short, Fig. 4 B summarizes an entire trajectory in a simple, intuitive 2D image. This object can further be used to cluster different independent unfolding trajectories either visually or through rigorous methods (see Supporting Material for an example of this).

α-Helix to β-strand transition of a mutant peptide from α-synuclein revealed by contact analysis

α-Synuclein is a well-studied disordered protein associated with the occurrence of Parkinson’s disease (26, 27, 28). As in the case of other neurodegenerative disorders mediated by peptides, the molecular basis of the disease is related to a profound structural transition from an α-helix to a β-sheet, which is an aggregation-prone state (29, 30). The mutation of glutamate to lysine at position 46 along the sequence (E46K) accelerates cytotoxicity of α-synuclein inside cells (31, 32, 33, 34). We have chosen this system to show that CONAN can readily identify the pathological conformational transition from α-helix to β-strand. The simulations, performed in replicates of 1 μs, repeatedly show an abrupt conformational change from a starting α-helical conformation into a random coil and finally into a β-hairpin.

The cluster analysis on the trajectories of the simulated α-synuclein fragments reveals different behaviors for the wild-type and the E46K mutant. In the case of the wild-type, the fragment oscillates between three states defined by clusters 0, 1, and 3, which are mostly α-helical, while cluster 2 is scarcely populated and features a shorter helix and a more molten-globule configuration. The E46K mutant, on the other hand, shows a time-resolved evolution of the states leading to the formation of a β-hairpin, which is characteristic of intermediates assembling in fibrillary supramolecular structures (Fig. 5). We pinpoint the specific interactions responsible for these differences using CONAN (Figs. S6 and S7). The dendrograms of the wild-type and the mutant fragment can be found in Figs. S8 and S9.

Figure 5.

Figure 5

Contact-based cluster analysis of the wild-type and mutated (E46K) form of α-synuclein investigated using CONAN. (A) and (C) show the inter-frame RMSD of the trajectories (see Methods for details) describing the conformational dynamics of the simulated peptides. (B) and (D) show the clustering obtained for the simulated ensemble. The graphs describe the time evolution of clusters with points colored according to the distance of each conformation from the cluster medoid (circled). The 3D structures for each medoid color-coded by secondary structure are shown on the right-hand side of the figure. To see this figure in color, go online.

Conclusions

Biological function is ultimately linked to molecular structure and its motions. The analysis of molecular contacts is exceptionally useful to map particular dynamic events that characterize the physiological or pathological behavior of macromolecules onto a molecular structure. Although bearing a plentiful amount of information and being extensively used to visualize static information (crystal structures or averages over the simulated time), contact maps have not been widely employed to visualize or interpret dynamical information. Here, we developed a tool that constructs time-resolved contact maps and also performs statistical, principal component, or cluster analyses to extract evidence of how specific contacts contribute to the overall observed dynamics of a macromolecule. CONAN is a tool developed with the purpose to combine the analysis of contacts to a series of analytic frameworks and to provide a highly automated instrument for a varied analysis of contacts with respect to the conformational ensembles explored by MD simulations. With the use of a single input file, CONAN computes contact maps and provides a range of publication-grade figures and videos that are automatically generated and show how specific contacts are responsible for an investigated behavior.

Interestingly, the analysis of unfolding trajectories by means of monitoring formation and rupture of contacts can not only reveal contact rupture but also the formation of new and variably transient contacts. Such analyses can be applied to understand folding of molecules in which exhaustive sampling is provided and can, for instance, reveal the formation of local element structures along a folding pathway (24, 25) to reveal cooperative effects in protein-coupled binding and folding processes (35) or critically functional allosteric and catalytic events along protein structures (36). We believe that the highly automated output creation and the simplicity of the user interface is key to a widespread use of the contact-based analyses presented, which can enhance the understanding of molecular systems far beyond the test cases presented here.

Author Contributions

D.M. and C.D. performed the simulations and data analysis. All three authors planned and wrote the manuscript. C.D. conceived of and wrote the software.

Acknowledgments

All three authors acknowledge funding from the Klaus Tschira Foundation. We thank Michael Feig for providing MD data as a test case (Supporting Material). C.D. acknowledges help from Vedran Miletić for coding advice and help with setting up the GitHub repository and thanks Helene H. Thygesen for helpful discussions on statistical analysis.

Editor: D. Peter Tieleman.

Footnotes

Supporting Materials and Methods, seventeen figures, and five movies are available at http://www.biophysj.org/biophysj/supplemental/S0006-3495(18)30193-0.

Supporting Material

Document S1. Supporting Materials and Methods and Figs. S1–S17
mmc1.pdf (38.3MB, pdf)
Movie S1. Ubiquitin Unfolding: Framewise Contact Maps
Download video file (1.6MB, mp4)
Movie S2. Ubiquitin Unfolding: Framewise Differential Contact Maps with Regard to Initial Frame
Download video file (1.6MB, mp4)
Movie S3. Ubiquitin Unfolding: Framewise Differential Contact Maps with Regard to Previous Frame
Download video file (1.3MB, mp4)
Movie S4. α-Synuclein Fragment: Wild-Type
Download video file (9.8MB, mp4)
Movie S5. α-Synuclein Fragment: E46K Mutant
Download video file (9.8MB, mp4)
Document S2. Article plus Supporting Material
mmc7.pdf (39.8MB, pdf)

References

  • 1.Mirny L., Domany E. Protein fold recognition and dynamics in the space of contact maps. Proteins. 1996;26:391–410. doi: 10.1002/(SICI)1097-0134(199612)26:4<391::AID-PROT3>3.0.CO;2-F. [DOI] [PubMed] [Google Scholar]
  • 2.Pulim V., Berger B., Bienkowska J. Optimal contact map alignment of protein-protein interfaces. Bioinformatics. 2008;24:2324–2328. doi: 10.1093/bioinformatics/btn432. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 3.Vassura M., Margara L., Casadio R. FT-COMAR: fault tolerant three-dimensional structure reconstruction from protein contact maps. Bioinformatics. 2008;24:1313–1315. doi: 10.1093/bioinformatics/btn115. [DOI] [PubMed] [Google Scholar]
  • 4.Vendruscolo M., Domany E. Protein folding using contact maps. Vitam. Horm. 2000;58:171–212. doi: 10.1016/s0083-6729(00)58025-x. [DOI] [PubMed] [Google Scholar]
  • 5.Kellogg E.H., Lange O.F., Baker D. Evaluation and optimization of discrete state models of protein folding. J. Phys. Chem. B. 2012;116:11405–11413. doi: 10.1021/jp3044303. [DOI] [PubMed] [Google Scholar]
  • 6.Nath A., Sammalkorpi M., Rhoades E. The conformational ensembles of α-synuclein and tau: combining single-molecule FRET and simulations. Biophys. J. 2012;103:1940–1949. doi: 10.1016/j.bpj.2012.09.032. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Sethi A., Tian J., Gnanakaran S. Identification of minimally interacting modules in an intrinsically disordered protein. Biophys. J. 2012;103:748–757. doi: 10.1016/j.bpj.2012.06.052. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 8.Grubmüller H. Force probe molecular dynamics simulations. Methods Mol. Biol. 2005;305:493–515. doi: 10.1007/978-1-59259-912-7_23. [DOI] [PubMed] [Google Scholar]
  • 9.Kozma D., Simon I., Tusnády G.E. CMWeb: an interactive on-line tool for analysing residue-residue contacts and contact prediction methods. Nucleic Acids Res. 2012;40:W329–W333. doi: 10.1093/nar/gks488. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10.Rafferty, B., Z. C. Flohr, and A. Martini. 2014. Protein contact maps. https://nanohub.org/resources/contactmaps.
  • 11.Vehlow C., Stehr H., Lappe M. CMView: interactive contact map visualization and analysis. Bioinformatics. 2011;27:1573–1574. doi: 10.1093/bioinformatics/btr163. [DOI] [PubMed] [Google Scholar]
  • 12.Krishnamani V. CMPyMOL: a tool for protein contact-map analysis. bioRxiv. 2016 https://doi.org/10.1101/084269 [Google Scholar]
  • 13.Ward J.H., Jr. Hierarchical grouping to optimize an objective function. J. Am. Stat. Assoc. 1963;58:236–244. [Google Scholar]
  • 14.Sittel F., Jain A., Stock G. Principal component analysis of molecular dynamics: on the use of Cartesian vs. internal coordinates. J. Chem. Phys. 2014;141:014111. doi: 10.1063/1.4885338. [DOI] [PubMed] [Google Scholar]
  • 15.Ramage R., Green J., Shaw K. Synthetic, structural and biological studies of the ubiquitin system: the total chemical synthesis of ubiquitin. Biochem. J. 1994;299:151–158. doi: 10.1042/bj2990151. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16.Mirecka E.A., Shaykhalishahi H., Hoyer W. Sequestration of a β-hairpin for control of α-synuclein aggregation. Angew. Chem. Int. Ed. Engl. 2014;53:4227–4230. doi: 10.1002/anie.201309001. [DOI] [PubMed] [Google Scholar]
  • 17.Nawrocki G., Wang P.H., Feig M. Slow-down in diffusion in crowded protein solutions correlates with transient cluster formation. J. Phys. Chem. B. 2017;121:11072–11084. doi: 10.1021/acs.jpcb.7b08785. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 18.Best R.B., Hummer G. Coordinate-dependent diffusion in protein folding. Proc. Natl. Acad. Sci. USA. 2010;107:1088–1093. doi: 10.1073/pnas.0910390107. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 19.Abraham M.J., Murtola T., Lindahl E. Gromacs: high performance molecular simulations through multi-level parallelism from laptops to supercomputers. SoftwareX. 2015;1:19–25. [Google Scholar]
  • 20.Williams, T., and C. Kelley. 2013. Gnuplot 4.6: an interactive plotting program. http://gnuplot.sourceforge.net/.
  • 21.Green D.A. A colour scheme for the display of astronomical intensity images. Bull. Astron. Soc. India. 2011;39:289–295. [Google Scholar]
  • 22.Harrower M., Brewer C.A. ColorBrewer.org: an online tool for selecting colour schemes for maps. Cartogr. J. 2003;40:27–37. [Google Scholar]
  • 23.Piana S., Lindorff-Larsen K., Shaw D.E. Atomic-level description of ubiquitin folding. Proc. Natl. Acad. Sci. USA. 2013;110:5915–5920. doi: 10.1073/pnas.1218321110. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 24.Lindorff-Larsen K., Maragakis P., Shaw D.E. Systematic validation of protein force fields against experimental data. PLoS One. 2012;7:e32131. doi: 10.1371/journal.pone.0032131. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25.Das A., Mukhopadhyay C. Mechanical unfolding pathway and origin of mechanical stability of proteins of ubiquitin family: an investigation by steered molecular dynamics simulation. Proteins. 2009;75:1024–1034. doi: 10.1002/prot.22314. [DOI] [PubMed] [Google Scholar]
  • 26.Flagmeier P., Meisl G., Galvagnion C. Mutations associated with familial Parkinson’s disease alter the initiation and amplification steps of α-synuclein aggregation. Proc. Natl. Acad. Sci. USA. 2016;113:10328–10333. doi: 10.1073/pnas.1604645113. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 27.Li W., West N., Lee M.K. Aggregation promoting C-terminal truncation of α-synuclein is a normal cellular process and is enhanced by the familial Parkinson’s disease-linked mutations. Proc. Natl. Acad. Sci. USA. 2005;102:2162–2167. doi: 10.1073/pnas.0406976102. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 28.Volpicelli-Daley L.A., Luk K.C., Lee V.M. Exogenous α-synuclein fibrils induce Lewy body pathology leading to synaptic dysfunction and neuron death. Neuron. 2011;72:57–71. doi: 10.1016/j.neuron.2011.08.033. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 29.Lashuel H.A., Overk C.R., Masliah E. The many faces of α-synuclein: from structure and toxicity to therapeutic target. Nat. Rev. Neurosci. 2013;14:38–48. doi: 10.1038/nrn3406. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30.Narkiewicz J., Giachin G., Legname G. In vitro aggregation assays for the characterization of α-synuclein prion-like properties. Prion. 2014;8:19–32. doi: 10.4161/pri.28125. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 31.Fredenburg R.A., Rospigliosi C., Lansbury P.T., Jr. The impact of the E46K mutation on the properties of α-synuclein in its monomeric and oligomeric states. Biochemistry. 2007;46:7107–7118. doi: 10.1021/bi7000246. [DOI] [PubMed] [Google Scholar]
  • 32.Wise-Scira O., Dunn A., Coskuner O. Structures of the E46K mutant-type α-synuclein protein and impact of E46K mutation on the structures of the wild-type α-synuclein protein. ACS Chem. Neurosci. 2013;4:498–508. doi: 10.1021/cn3002027. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33.Emmer K.L., Waxman E.A., Giasson B.I. E46K human alpha-synuclein transgenic mice develop Lewy-like and tau pathology associated with age-dependent, detrimental motor impairment. J. Biol. Chem. 2011;286:35104–35118. doi: 10.1074/jbc.M111.247965. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 34.Zarranz J.J., Alegre J., de Yebenes J.G. The new mutation, E46K, of alpha-synuclein causes Parkinson and Lewy body dementia. Ann. Neurol. 2004;55:164–173. doi: 10.1002/ana.10795. [DOI] [PubMed] [Google Scholar]
  • 35.Kovacs D., Szabo B., Tompa P. Intrinsically disordered proteins undergo and assist folding transitions in the proteome. Arch. Biochem. Biophys. 2013;531:80–89. doi: 10.1016/j.abb.2012.09.010. [DOI] [PubMed] [Google Scholar]
  • 36.Doshi U., Holliday M.J., Hamelberg D. Dynamical network of residue-residue contacts reveals coupled allosteric effects in recognition, catalysis, and mutation. Proc. Natl. Acad. Sci. USA. 2016;113:4735–4740. doi: 10.1073/pnas.1523573113. [DOI] [PMC free article] [PubMed] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

Document S1. Supporting Materials and Methods and Figs. S1–S17
mmc1.pdf (38.3MB, pdf)
Movie S1. Ubiquitin Unfolding: Framewise Contact Maps
Download video file (1.6MB, mp4)
Movie S2. Ubiquitin Unfolding: Framewise Differential Contact Maps with Regard to Initial Frame
Download video file (1.6MB, mp4)
Movie S3. Ubiquitin Unfolding: Framewise Differential Contact Maps with Regard to Previous Frame
Download video file (1.3MB, mp4)
Movie S4. α-Synuclein Fragment: Wild-Type
Download video file (9.8MB, mp4)
Movie S5. α-Synuclein Fragment: E46K Mutant
Download video file (9.8MB, mp4)
Document S2. Article plus Supporting Material
mmc7.pdf (39.8MB, pdf)

Articles from Biophysical Journal are provided here courtesy of The Biophysical Society

RESOURCES