Skip to main content

Rinmaker: a fast, versatile and reliable tool to determine residue interaction networks in proteins

Abstract

Background

Residue Interaction Networks (RINs) map the crystallographic description of a protein into a graph, where amino acids are represented as nodes and non-covalent bonds as edges. Determination and visualization of a protein as a RIN provides insights on the topological properties (and hence their related biological functions) of large proteins without dealing with the full complexity of the three-dimensional description, and hence it represents an invaluable tool of modern bioinformatics.

Results

We present RINmaker, a fast, flexible, and powerful tool for determining and visualizing RINs that include all standard non-covalent interactions. RINmaker is offered as a cross-platform and open source software that can be used either as a command-line tool or through a web application or a web API service. We benchmark its efficiency against the main alternatives and provide explicit tests to show its performance and its correctness.

Conclusions

RINmaker is designed to be fully customizable, from a simple and handy support for experimental research to a sophisticated computational tool that can be embedded into a large computational pipeline. Hence, it paves the way to bridge the gap between data-driven/machine learning approaches and numerical simulations of simple, physically motivated, models.

Peer Review reports

Background

Recent successes of Alphafold [1] and following up analyses [2, 3] have clearly put in the limelight the power of data driven approaches in structural biology, with the number of predicted folds that is now exceeding the number of experimentally accessible protein crystals by few orders of magnitude. A detailed analysis of the three dimensional structure of a protein is clearly of paramount importance for mapping out its specific properties and hence its functionality. However, a direct use of the three-dimensional structure, when possible, has proven highly computational demanding. Residue Interaction Network (RIN) is a graph where nodes are amino acids and edges represent non-covalent interactions and can be regarded as a possible alternative whenever only information regarding the protein topology and the distribution of the specific non-covalent interactions are required.

While there are various tools in the literature for implementing and analysing RINs—see [4] for a recent survey, most of them are either embedded in a Molecular Dynamics (MD) package or are specifically designed to analyze MD trajectories and to produce as output an analysis of the corresponding networks. Usually such tools determine the \(C_{\alpha }\) or \(C_{\beta }\) contact maps, or general non-covalent contacts based on atoms proximity. Some tools in the literature calculate specific non-covalent bonds [5,6,7,8], but they all come with their own shortcomings and drawbacks. RING 3.0 [5] and RIP-MD [9] are offered as a black box tool as their code is not available. Arpeggio [8] and its recent refactoring PDBe-Arpeggio [10] is an open source tool that considers a wide set of specific bonds. However, the user cannot tune the bonds thresholds, energies are not computed, and the execution is not computationally efficient. In general, a serious drawback of the tools in the literature is that the correctness of the obtained RINs is not addressed. Another common issue concerns the computational efficiency of the RIN calculation: usually the performance evaluation of the proposed algorithm is missing or insufficiently addressed.

A recent study by some of us developed a computational pipeline combining homology modeling, machine learning and graph theory techniques for the analysis of point mutations in the sequence of a specific membrane protein [11]. In that framework, one of the available tools [7] was used to generate the RIN, and that experience prompted the need for a new tool able to overcome all the above drawbacks.

To fill this gap we present RINmaker, a tool for determining and visualizing the RIN of a protein given in input. RINmaker is offered as a cross-platform and open source software that can be used either as a command-line tool or through a web application featuring a modern 3D user interface. Additionally, we offer a web API service for embedding RINmaker into third-party clients. RINmaker allows for determining the \(C_{\alpha }\) contact map and a comprehensive set of non-covalent interactions. For each considered bond either default or user specified thresholds can be used for the calculation, resulting in a versatile tool. Moreover, we developed a custom integration test system to ensure the program correctness. The whole test suite is distributed along with the application, allowing anyone to reproduce the test results. Finally, computational efficiency was the main focus while designing and developing RINmaker. For this reason, we assessed the tool’s efficiency through a series of performance evaluation tests, which highlighted that RINmaker can be used in any context where high-throughput production of RINs is required. RINmaker is supported by a detailed supplementary document (see Additional file 1) for all employed rules to identify different non-covalent interactions, as well as for the custom test cases used to assess the program correctness.

Implementation

The main goal in designing RINmaker was computational efficiency, which guided all the implementation choices. The style of Generic Programming (GP) [12] has been adopted as it enforces a number of optimizations. By properly defining copy-constructors, assignment operators and move-constructors for custom datatypes, C++ and GP allows avoiding unwanted replications of data structures, boosting the overall performance. By using the template system rather than the classic object-oriented programming style based on subtype polymorphism and dynamic dispatching [13], the C++ language grants maximum efficiency thanks to the static dispatching of methods and to a number of other compile-time optimizations.

A second goal was to ensure the RINmaker correctness. To this aim, the use of advanced preprocessor macros and C++11 lambdas played an important role in designing a programmable and versatile test suite.

In this section we present the RINmaker workflow and main features and describe how we addressed the efficiency and correctness issues.

RINmaker workflow and main features

The RINmaker workflow is illustrated in Fig. 1. The core of RINmaker consists of one executable that receives in input the 3D structure of a protein and produces in output a file representing the corresponding RIN. RINmaker is offered as an application supporting multiple user interfaces:

Fig. 1
figure 1

The RINmaker flow: The 3D structure of a protein (left) is mapped into a RIN network (right) via different possibilities (command-line, web API and web GUI). As a specific example, the red and blue amino acids highlighted in the protein structure on the left are mapped into the corresponding nodes on the right

  • A console application from the command line with a wide range of possible arguments allowing the user to fine-tune bond parameters, such as distance threshold, orientational angles, etc. All such parameters have default values that are reasonable in most cases.

  • An HTTP-based API available for third-party applications requiring RINmaker as a service. Clients can upload an input file through an HTTP post to the API where the content of the input file appears in the body in JSON format and download the resulting RIN via marshalling and unmarshalling in JSON format.

  • A GUI web application running RINmaker in the background on the server side. The user can search an input file in the PDB databank or upload a local file, select the desired parameters for the non-covalent bonds and visualize the resulting RIN through a real-time rendered 2D or 3D representation, see an example in Fig. 2. Smooth motion, rotation and zoom are available, delivering a 60+ fps experience on an average machine (an Intel i5 10th generation processor with an integrated GPU). This helps the user exploring the RIN, observing bonds and retrieving relevant information on the network structure, the details of nodes and edges and some overall statistics.

Fig. 2
figure 2

The RINmaker user interface: RIN 3D visualization

The main features of RINmaker are the following:

  • It supports both mmCIF and PDB as input file formats.

  • The output RIN is by default generated in GraphML format [14]. A special CLI option allows for the generation of two CSV output files, one for the nodes and one of the edges of the RIN, in place of a single GraphML file.

  • It allows for easily processing snapshots in MD trajectories. The entire MD trajectory, stored into a single PDB file, can be handled by RINmaker to output a single RIN for each individual snapshot. Indeed, RINmaker supports multiple models within a single input file. A special command line flag makes RINmaker perform a separate run for each model, outputting all the RINs as distinct files into a single directory.

  • It determines the \(C_\alpha\) contact-map as well as the following non-covalent interactions: H-bonds, Van der Waals interactions, ionic bridges, \(\pi\)-\(\pi\) stacks, \(\pi\)-cation interactions. We included also “hydrophobic interactions” in view of their frequent reference in the literature [15], even if, strictly speaking, such bond does not exist as it is the effective combination of several different contributions, partially of entropic origin.

  • It provides a set of attributes for the RIN nodes and edges, such as the type of bond, the involved atoms, their distance, orientation and energy. For each bond, energy is calculated as a function of the distance between atoms and their relative orientation in space, rather than using approximated constant values available in the literature. This allows for a more accurate evaluation of the interactions. Specific formulas and tables for energy calculation are available in the Additional file 1.

Computational efficiency

Computational efficiency of RINmaker deserves a detailed discussion. Searching for non-covalent bonds among all the atoms of a protein would require \(O(n^2)\) operations, n being the number of atoms. As a consequence, the choice of an efficient data structure was mandatory. We resorted to the use of kD-Trees, as they allow for an efficient representation of k-dimensional spatial information and a low cost proximity search algorithm [16]. We implemented a kD-Tree library in C++ for achieving maximum performance while retaining a strongly typed approach: dimension k is represented by an integer template argument, in the style of template meta-programming [17], which allows for inlining of constant expressions and other compile-time optimizations for \(k = 3\), since the protein structure is represented in a 3D space [18]. The program builds a balanced kD-Tree representing the protein 3D structure in \(O(n \log ^2 n)\) time, with n being the number of atoms in the input file. With such data structure, the search for non-covalent bonds becomes the search for neighbouring nodes in the balanced kD-tree, which runs in \(O(\log n)\) time on average and in O(n) time in the worst case. The advantage of adopting the kD-tree data structure and the related proximity search algorithm clearly emerges when assessing the RINmaker performance, as reported in the Results and Discussion section.

Test suite

RINmaker is provided with a custom integration test system based on the Google Test Framework [19]. The program can be compiled in test mode to run a series of tests. Tests are on two levels: tests of single code portions and functions; and tests of the whole program over a given input file. Code-level tests are modular and reusable thanks to advanced macro usage within C++, allowing for easy creation of new tests. A series of input sample PDB files specifically designed for testing the program behaviour on the various bonds are included with the RINmaker distribution. Moreover, a detailed description of all molecules included in tests along with the expected results is included in the Additional file 1.

RINmaker can be built either in application mode for producing the normal executable, or in test mode for producing a special executable aimed at testing the program. The test mode executable can be obtained by compiling the program with a specific compile-time flag, or, more simply, by running cmake with the Test target.

The test mode executable simulates multiple runs of the normal application mode execution. This allows for performing a series of tests in a single run of the program. Each test is performed with a specific combination of command line arguments. Moreover, to speed-up the testing process, each output RIN is kept in memory rather than being dumped to an output file, thus avoiding the re-parsing of the output files when comparing the output bonds against the expected ones.

The main advantages of such test system are scalability and maintainability. Writing new test cases with new molecules is straightforward as well as adapting existing ones to new scenarios.

Results and discussion

In this section we present a case study where RINmaker is employed for the analysis of a molecular dynamic trajectory. We present moreover some performance evaluation tests that confirm the efficiency of RINmaker.

Using RINmaker for data analysis of a molecular dynamics trajectory

One of the added values of mapping a 3D structure into a network stems from the various probes that can be used to identify emerging patterns that are not immediately visible from the original structure. We provide here an interesting example of this idea using RINmaker, thus showing the efficiency of the tool within this framework.

Consider Trp-cage (file 1L2Y.pdb in the Protein Databank [20]), a small protein made of 20 aminoacids. Since it is a fast folding protein (folding time in the nsec time domain), it has been thoroughly studied and its structure and properties are rather well understood [21, 22].

Fig. 3
figure 3

Native state of the Trp-Cage miniprotein with a \(Cl^{-}\) as counter ion (Model 1 in the 1L2Y.pdb file)

The Trp-cage native 3D structure is depicted in Fig. 3 and contains a short \(\alpha\)-helix in residues 2–9, a 310-helix in residues 11–14, and a C-terminal polyproline II helix to pack against the central tryptophan (Trp-6) [21]. The latter residue appears to be involved in the formation/breaking of side-chain bonds during the various folding-unfolding processes, because of its preferential position in the core region [22]. Using molecular dynamics in explicit water TIP3P [23] with the CHARMM36 force-field [24], we first equilibrated the Trp-cage protein for 45 nsec in NPT ensemble with pressure equal to 1 atm kept constant with a Monte Carlo barostat [25]. Then a NVT production run of additional 45 nsec was performed at temperature 480K and at temperature 330 K. In all cases it was used a Langevin Integrator with timestep set to 2 psec. All simulations were performed using the OpenMM [26] python package.

From [21], it is known that with the use of the CHARMM36 force field, the ground-state (folded state) of the protein is well maintained at 330K, and that the melting point corresponding to denaturation of the protein, appears around 440K. Other studies show that the folded state is preserved exclusively by Trp at position 6 in the protein in the folded-state, while a denaturation involves a disruption of Trp’s noncovalent interactions with other nearby residues. Thus, the choice of temperatures at 330K and 480K were selected to emphasize these two different states of the protein in the free energy landscape.

During the production run, a number of reaction coordinates can be computed to highlight the behaviour of the protein at that specific temperature. In this case, we selected the radius of gyration that signals the onset of the folding of the protein, and the betweenness centrality computed on the RIN obtained via the use of RINmaker. The betweenness centrality is the ratio between the number of shortest paths passing through a specific node (i.e. a residue) and the number of total shortest paths in the network. The betweenness centrality is known to be an important indicator of the residue function of a protein upon a mutation of a given residue [27], and we show that this information is indeed captured by the RIN topology via our RINmaker tool.

For each snapshot of the trajectory (every 30ps), the radius of gyration and the RIN were computed. The latter was used to further compute the betweenness centrality using the Networkx [28] python package. Both these quantities were then accumulated in histograms that were then used for a free energy landscape analysis following standard prescriptions [21].

Figure 4 displays the betweenness centrality of each of the 20 residues of the Trp-Cage as a function of the simulation time \(t/\Delta t\) (units of \(\Delta t =30\) psec) for two temperatures: (top panel) T = 330 K below the folding temperature (\(T \approx 400\,K\)) and (bottom panel) T = 480 K above it. The primary role played by Trp6 at T = 330 K can be clearly appreciated at a glance, and it agrees with past results [29] as further elaborated below. Above the folding temperature, precisely at T = 480 K, this prominence is lost at an early stage of the simulation and other residues, notably Arg16 and Gly11, begin to display their importance. This can be rationalized with the breaking and reforming of bonds as well as the stabilization of another local minimun. This process is captured by the free energy landscape calculations as illustrated in Fig. 5.

Fig. 4
figure 4

Betweenness centrality of the Trp-Cage residues as a function of the simulation time \(t/\Delta t\) (\(\Delta t=30\) psec) during the trajectory at temperatures above and below the folding temperature (\(\approx 400K\)). Top panel \(T=330\,K\); Bottom panel \(T=480\,K\)

Figure 5 reports a contour plot of the free energy landscape as a function of the radius of gyration and the betweenness centrality at two different temperatures: \(T=330\,K\) (left panel) and \(T=480\,K\) (right panel). As the folding temperature is expected to be around 400K [30], the first temperature is below the folding temperature whereas the second is above.

In agreement with previous studies [31], we notice that at T = 330 K there is a well defined minimum (A) corresponding to the native state. This minimum becomes unstable at T = 480 K, above the folding temperature, due to a partial denaturation of one particular alpha-helix, thus driving the system toward another minimum (B). It should be emphasized that while this scenario is fully consistent with previous studies [31], specific details are not in view of the different force fields and different reaction coordinates employed. In this respect, the use of the betweenness centrality, and in turn of RINmaker, has proven very useful as it provides a much cleaner free energy landscape compared with previous one, thus highlighting the importance of RINmaker as a computational tool that can be embedded into a computational pipeline.

Fig. 5
figure 5

Free energy landscape of Trp-Cage as a function of the radius of gyration and of the betweenness centrality at temperatures (left) T = 330 K and (right) T = 480 K. Snapshots of the conformation corresponding to stable local minima are given in A for T = 330 K and in B for T = 480 K with highlighted the Gly11, Arg16 and Tpr6 residues involved in the transition between one minimum to the other. In B it is also possible to observe the denaturated \(\alpha\)-helix highlighted in yellow

The results reported in Fig. 4 have underpinned the fundamental role of Trp6 residue that is unveiled by the analysis of the betweenness centrality as obtained via RINmaker. Further insights can be obtained by plotting the actual value of betweenness centrality during the time evolution, as illustrated in Fig. 6. At 330 K the betweenness centrality remains stable, indicating an equlibrium localized in minimum A of Fig. 5. At 480K, the betweenness centrality displays a significant oscillatory behavior indicating a coexistence with another minimum (indicated as B in Fig. 5) throughout the entire trajectory. This can be ascribed to the salt-bridges and side-chain H-Bonds that this residue forms/breaks with the neighbour side-chains which shift the protein conformation between A and B [21]. The various spikes that can be seen in the process are probably due to the solvent noise and the transient interactions found by RINmaker when building the RIN.

Fig. 6
figure 6

Betweenness centrality of residue Trp6 in the Trp-Cage trajectory obtained from RINmaker, at the two different temperatures (T = 330 K and T = 480 K)

Performance evaluation

In this section we illustrate the performance tests that have been designed and performed for RINmaker. All tests were executed on a mid-end machine, namely a ThinkPad E590 laptop equipped with Intel i7-8565U CPU, 16GB of RAM and a 500GB SSD.

The first test aimed at evaluating the running time of the software for a wide set of proteins. We considered the TOP2018 [32] database and created a script to run RINmaker for all proteins stored in the database, which contains 13,678 entries (pdb files) corresponding to all single chains of the considered proteins. All the created RINs were obtained by using the default values for all input parameters. We measured that the average time to build the RIN for each entry was approximately 66 ms, for a total of 15 min for the entire database. We also computed the frequency per bond for the obtained RINs, which is reported in Table 1. The reported frequency values are in agreement with the general knowledge in the literature.

Table 1 Bonds frequency (%) calculated for the RINs of the TOP2018 database

The second test was a performance comparison between RINmaker, and the most similar tools in the literature, namely RING 3.0 [5] and PDBe-Arpeggio [10]. Note that, since RING 3.0 source code is unavailable, the test has been performed using the executables of the command-line version of the tool. For PDBe-Arpeggio we used the available Python scripts. While RINmaker and RING 3.0 are very similar in their general structure, PDBe-Arpeggio significantly departs from both on them on the count that it does not allow users to customize bond parameters (angles, distances, etc), and it heavily relies on external tools such as Open Babel [33].

The test aimed at evaluating the performance of the three tools for a small set of proteins available in the PDB databank and having an increasing number of amino acids. Table 2 shows the considered set of proteins and reports, for each of them, the user CPU time needed by all the three tools for creating their corresponding RIN. Each reported value has been averaged over ten runs values. The addition of hydrogen atoms is an optional operation in RINmaker and RING 3.0, while it is always included in PDBe-Arpeggio. Hence, for RINmaker and RING 3.0, the user CPU time is reported for both cases (i.e. with and without hydrogen addition). We remark that for each protein and run, RINmaker and RING 3.0 received the same input parameters. However, it is worth mentioning that, although the two tools operated at the same conditions, they do not perform exactly the same activities. In particular:

  • RING 3.0 run the DSSP algorithm for secondary structure prediction [34], which is not included in RINmaker;

  • Both tools report the H-bonds, VdW bonds, Ionic bonds, \(\pi -\pi\) stacks and \(\pi -\)Cations. However, RINmaker reports also the hydrophobic bonds, which are not included in RING 3.0.

By contrast, in PDBe-Arpeggio everything is pre-defined thus lacking on any possibility of a customized use, as already remarked.

Table 2 Performance tests on an Intel i7-8565U CPU: RINmaker versus RING 3.0 versus PDBe-Arpeggio

Looking at Table 2 it is clear that RINmaker outperforms PDBe-Arpeggio and RING 3.0 in all tests by at least one order of magnitude in most cases. It is also interesting to point out that the low user CPU times employed by RINmaker when dealing with small molecules imply that the program startup time, consisting of parsing the input and setting up data structures, is negligible compared to the processing time. This feature makes RINmaker ideal to be embedded into other tools, scripts or pipelines.

A different view of the comparison between RINmaker and RING 3.0 is shown in Fig. 7. It considers the user CPU time distribution w.r.t. the number of residues in the input files and shows the results of both tools in the two cases, namely with and without hydrogen addition. The results highlights even more the different performances of the two tools, RINmaker being the most efficient one. Note that the RINmaker CPU times grow very slowly w.r.t. the number of residues (it is a linear growth in case no hydrogen atoms are added), making it suitable for proteins of any size.

Fig. 7
figure 7

Performance tests: CPU time as a function of the number of residues. RINmaker (blue) vs. RING 3.0 (orange)

Conclusion

RINmaker has been designed to be a flexible, reliable and fast tool to build and visualize RINs. Future developments of RINmaker include the extension of its web interface with additional visualization features as well as detailed analyses on the obtained RINs. In the current version, the web interface allows the 2D and 3D RIN visualization and offers some basic statistics. We would like to include the topological analysis of the obtained RIN and specific analyses associated to RINs determined on a MD trajectory, which could reveal interesting information on the simulated protein. Moreover, RINmaker is going to be linked to XRmol [35, 36], a web-based protein structure viewer that provides interactive 3D display of proteins and nucleic acids in different environments, including desktop computers and devices supporting Augmented Reality. The combination of the two tools, possible thanks to the web API available for RINmaker, will allow for depicting all non-covalent bonds calculated by RINmaker directly in the protein’s 3D structure visualized by XRmol.

The importance of having an efficient tool to construct RINs should not be underestimated. RINs provide a graph theoretical representation of a protein (or a protein domain) that captures the crucial complexity of the biomolecule at a glance and translates it into a set of quantitative indicators that are crucial to understand its function. A major challenge is to be able to achieve this dimensional reduction without loosing crucial information of its high-dimensional conformational space.

Efforts along these lines have recently been proposed [37] whose findings are complementary to ours thus providing further support on the impact that the tool proposed in this study may have in the near future.

Availability of data and materials

Data analyzed in this paper are available at the PDB Data Bank [20] and at the TOP2018 database [32]. Both of them are public databases. Availability and requirements: Program name: RINmaker; Web UI: https://rinmaker.dais.unive.it/; Programming language: C++; Other requirements: none. License: The code is open source and available at github.com/RINmaker under the GNU Affero General Public License. Downloads: Binaries are available for multiple operating systems at github.com/RINmaker/RINmaker/releases. Contact: rinmaker@unive.it. Any restrictions to use by non-academics: none.

References

  1. Jumper J, Evans R, Pritzel A, et al. Highly accurate protein structure prediction with alphafold. Nature. 2021;596(7873):583–9. https://doi.org/10.1038/s41586-021-03819-2.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Tunyasuvunakool K, Adler J, Wu Z. Highly accurate protein structure prediction for the human proteome. Nature. 2021;596:590–6.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  3. Baek MFD, Anishchenko I, et al. Accurate prediction of protein structures and interactions using a three-track neural network. Science. 2021;373(6557):871–6. https://doi.org/10.1126/science.abj8754.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  4. Liang Z, Verkhivker GM, Hu G. Integration of network models and evolutionary analysis into high-throughput modeling of protein dynamics and allosteric regulation: theory, tools and applications. Brief Bioinform. 2019;21(3):815–35. https://doi.org/10.1093/bib/bbz029.

    Article  CAS  Google Scholar 

  5. Clementel D, Del Conte A, Monzon AM, Camagni G, Minervini G, Piovesan D, Tosatto SCE. RING 3.0: fast generation of probabilistic residue interaction networks from structural ensembles. Nucleic Acids Res. 2022;50(W1):651–6.

    Article  Google Scholar 

  6. Martin AJ, Vidotto M, Boscariol F, Di Domenico T, Walsh I, Tosatto SC. RING: networking interacting residues, evolutionary information and energetics in protein structure. Bioinformatics. 2011;27(14):66.

    Article  Google Scholar 

  7. Piovesan D, Minervini G, Tosatto S. The RING 2.0 web server for high quality residue interaction networks. Nucleic Acids Res. 2016;44(W1):66.

    Article  Google Scholar 

  8. Jubb HC, Higueruelo AP, Ochoa-Montaño B, et al. Arpeggio: a web server for calculating and visualising interatomic interactions in protein structures. J Mol Biol. 2017;429(3):365–71. https://doi.org/10.1016/j.jmb.2016.12.004.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  9. Contreras-Riquelme S, Garate JA, Perez-Acle T, Martin AJM. RIP-MD: a tool to study residue interaction networks in protein molecular dynamics. PeerJ. 2018;6:5998. https://doi.org/10.7717/peerj.5998.

    Article  CAS  Google Scholar 

  10. PDBe-Arpeggio. 2023. https://github.com/PDBeurope/arpeggio.

  11. Toffano AA, Chiarot G, Zamuner S, Marchi M, Salvi E, Waxman SG, Faber CG, Lauria G, Giacometti A, Simeoni M. Computational pipeline to probe nav1. 7 gain-of-function variants in neuropathic painful syndromes. Sci Rep. 2020;10(1):17930.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  12. Alexandrescu A. Modern C++ design: generic programming and design patterns applied. Boston: Addison-Wesley; 2001.

    Google Scholar 

  13. Milton, S., Schmidt, H. Dynamic dispatch in object-oriented languages. Technical report, The Australian National University; 1994

  14. Brandes U, Eiglsperger M, Herman I, et al. Graphml progress report: structural layer proposal. In: Springer-Verlag (ed.) Proceedings of the 9th international symposium graph drawing (GD’01) (LNCS 2265); 2002. p. 501–512.

  15. Onofrio A, Parisi G, Punzi G, Todisco S, Di Noia MA, Bossis F, Turi A, De Grassi A, Pierri CL. Distance-dependent hydrophobic–hydrophobic contacts in protein folding simulations. Phys Chem Chem Phys. 2014;16:18907–17. https://doi.org/10.1039/C4CP01131G.

    Article  CAS  PubMed  Google Scholar 

  16. Chen Y, Zhou L, Tang Y, et al. Fast neighbor search by using revised k–d tree. Inf Sci. 2019;472:145–62. https://doi.org/10.1016/j.ins.2018.09.012.

    Article  Google Scholar 

  17. Abrahams D, Gurtovoy A. C++ template metaprogramming: concepts, tools, and techniques from boost and beyond. 1st ed. London: Pearson Education; 2004.

    Google Scholar 

  18. Andrist B, Sehr V. C++ high performance: master the art of optimizing the functioning of your C++ code. 2nd ed. Birmingham: Packt Publishing Ltd; 2020.

    Google Scholar 

  19. Inc. G. Google Test Framework. 2022. http://google.github.io/googletest/. Accessed 7 Dec 2022.

  20. Berman HM, Westbrook J, Feng Z, Gilliland G, Bhat TN, Weissig H, Shindyalov IN, Bourne PE. The protein data bank. Nucleic Acids Res. 2000;28:66. https://doi.org/10.1093/nar/28.1.235.

    Article  Google Scholar 

  21. Zhou R. Trp-cage: folding free energy landscape in explicit water. Proc Natl Acad Sci. 2003;100(23):13280–5. https://doi.org/10.1073/pnas.2233312100.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  22. Lee IH, Kim SY. Dynamic folding pathway models of the trp-cage protein. BioMed Res Int. 2013;2013:66. https://doi.org/10.1155/2013/973867.

    Article  CAS  Google Scholar 

  23. Jorgensen WL, Chandrasekhar J, Madura JD, Impey RW, Klein ML. Comparison of simple potential functions for simulating liquid water. J Chem Phys. 1983;79(2):926–35. https://doi.org/10.1063/1.445869.

    Article  CAS  Google Scholar 

  24. Huang J, MacKerell AD Jr. CHARMM36 all-atom additive protein force field: validation based on comparison to NMR data. J Comput Chem. 2013;34(25):2135–45.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  25. Andersen HC. Molecular dynamics simulations at constant pressure and/or temperature. J Chem Phys. 2008;72(4):2384–93. https://doi.org/10.1063/1.439486.

    Article  Google Scholar 

  26. Eastman P, Swails J, Chodera JD, McGibbon RT, Zhao Y, Beauchamp KA, Wang L-P, Simmonett AC, Harrigan MP, Stern CD, Wiewiora RP, Brooks BR, Pande VS. Openmm 7: rapid development of high performance algorithms for molecular dynamics. PLOS Comput Biol. 2017;13(7):1–17. https://doi.org/10.1371/journal.pcbi.1005659.

    Article  CAS  Google Scholar 

  27. Foutch D, Pham B, Shen T. Protein conformational switch discerned via network centrality properties. Comput Struct Biotechnol J. 2021;19:3599–608. https://doi.org/10.1016/j.csbj.2021.06.004.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  28. Hagberg A, Swart P, Chult SD. Exploring network structure, dynamics, and function using networkx. Technical report, Los Alamos National Lab.(LANL), Los Alamos; 2008.

  29. Kannan S, Zacharias M. Role of tryptophan side chain dynamics on the trp-cage mini-protein folding studied by molecular dynamics simulations. PLoS ONE. 2014;9(2):1–12. https://doi.org/10.1371/journal.pone.0088383.

    Article  CAS  Google Scholar 

  30. Wu X, Yang G, Zu Y, Fu Y, Zhou L, Yuan X. Molecular dynamics characterisations of the trp-cage folding mechanisms: in the absence and presence of water solvents. Mol Simul. 2012;38(2):161–71. https://doi.org/10.1080/08927022.2011.610795.

    Article  CAS  Google Scholar 

  31. Paschek D, Hempel S, García AE. Computing the stability diagram of the trp-cage miniprotein. Proc Natl Acad Sci. 2008;105(46):17754–9. https://doi.org/10.1073/pnas.0804775105.

    Article  Google Scholar 

  32. Williams C, Richardson D, Richardson J. High quality protein residues: top2018 mainchain- filtered residues. Zenodo. 2021. https://doi.org/10.5281/zenodo.5777651.

    Article  Google Scholar 

  33. O’Boyle NM, Banck M, James CA, Morley C, Vandermeersch T, Hutchison GR. Open babel: an open chemical toolbox. J Cheminform. 2011;3(1):33. https://doi.org/10.1186/1758-2946-3-33.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  34. Kabsch W, Sander C. Dictionary of protein secondary structure: pattern recognition of hydrogen-bonded and geometrical features. Biopolymers. 1983;22(12):2577–637. https://doi.org/10.1002/bip.360221211.

    Article  CAS  PubMed  Google Scholar 

  35. XRmol. 2023. https://xrmol.dais.unive.it.

  36. Corazza S, Pittarello F, Simeoni M. 3d molecules visualization with XRmol: an AR web tool for mobile devices. In: Springer (ed) 20th EuroXR international conference—EuroXR 2023, lecture notes in computer science. Accepted for publication; 2023.

  37. Franke L, Peter C. Visualizing the residue interaction landscape of proteins by temporal network embedding. J Chem Theor Comput. 2023;19(10):2985–95. https://doi.org/10.1021/acs.jctc.2c01228.

    Article  CAS  Google Scholar 

Download references

Acknowledgements

We thank Giulio Marcolin and Luca Lagunas for their preliminary contribution to the software. We thank Giulia Brolese for improving the RINmaker flow picture. The use of the SCSCF cluster at Ca' Foscari University of Venice. is gratefully acknowledged. We acknowledge the CINECA award under the ISCRA initiative, for the availability of high performance computing resources and support.

Funding

Not applicable.

Author information

Authors and Affiliations

Authors

Contributions

A.S., A.G., M.S.: software conceptualization. A.G., C.D.F, J.M.: non-covalent bonds rules specification. A.S., A.P., D.P., L.F.: command line program implementation. A.S., F.V.: web application and web API implementation. A.S., D.P., J.M.: tests cases development and test suite design and implementation. A.S., A.G., C.D.F., J.M., M.S.: paper and Supplementary Material writing. All authors revised the paper and the Supplementary Material. All authors read and approved the final manuscript.

Corresponding author

Correspondence to Marta Simeoni.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Additional information

Publisher's Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Supplementary Information

Additional file 1.

This document contains detailed information about non-covalent bonds and test cases.

Rights and permissions

Open Access This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made. The images or other third party material in this article are included in the article's Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article's Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder. To view a copy of this licence, visit http://creativecommons.org/licenses/by/4.0/. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated in a credit line to the data.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Spanò, A., Fanton, L., Pizzolato, D. et al. Rinmaker: a fast, versatile and reliable tool to determine residue interaction networks in proteins. BMC Bioinformatics 24, 336 (2023). https://doi.org/10.1186/s12859-023-05466-y

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12859-023-05466-y

Keywords