Skip to main content

ACPYPE - AnteChamber PYthon Parser interfacE

Abstract

Background

ACPYPE (or AnteChamber PYthon Parser interfacE) is a wrapper script around the ANTECHAMBER software that simplifies the generation of small molecule topologies and parameters for a variety of molecular dynamics programmes like GROMACS, CHARMM and CNS. It is written in the Python programming language and was developed as a tool for interfacing with other Python based applications such as the CCPN software suite (for NMR data analysis) and ARIA (for structure calculations from NMR data). ACPYPE is open source code, under GNU GPL v3, and is available as a stand-alone application at http://www.ccpn.ac.uk/acpype and as a web portal application at http://webapps.ccpn.ac.uk/acpype.

Findings

We verified the topologies generated by ACPYPE in three ways: by comparing with default AMBER topologies for standard amino acids; by generating and verifying topologies for a large set of ligands from the PDB; and by recalculating the structures for 5 protein–ligand complexes from the PDB.

Conclusions

ACPYPE is a tool that simplifies the automatic generation of topology and parameters in different formats for different molecular mechanics programmes, including calculation of partial charges, while being object oriented for integration with other applications.

Findings

Here we introduce ACPYPE, a tool based on ANTECHAMBER [1] for generating automatic topologies and parameters in different formats for different molecular mechanics programmes, including calculation of partial charges. In other to validate ACPYPE, we verified its topologies generated in three detailed ways: 1) by comparing with default AMBER [2] topologies for standard amino acids; 2) by generating and verifying topologies for a large set of ligands from the Protein Data Bank (PDB) [3]); and 3) by recalculating the structures for 5 protein–ligand complexes from the PDB. The Figure 1 summarises its resources and features, giving a general overview of how ACPYPE works.

Figure 1
figure 1

Workflow diagram for ACPYPE. Diagram depicting the general scheme of how ACPYPE works. Encompassed by the traced line is the ACPYPE functionality already implemented as a web service at http://webapps.ccpn.ac.uk/acpype.

Background

Molecular Mechanics (MM) has evolved substantially over the last decades, not only because of major advances in computational power, but also due to more accurate and diverse force field descriptions. Molecular Dynamics (MD) and NMR Structure Calculation software (NMR-SC) have matured in line with these advances in MM to become more complex, faster and precise; MD and NMR-SC software packages can now perform calculations that were previously thought to be very difficult to handle [4].

Such calculations, however, always depend on a precise and complete description of the topology and physical parameters of the molecules they tackle. The methods to obtain these descriptions are well developed for common bio-molecular components like amino acids and nucleic acids, but reliable and automatic procedures to obtain this information for heterogeneous chemical compounds are scarce. Researchers trying to address, for example, protein–ligand complexes often have to manually create the topologies for their ligands, a procedure which creates additional overhead and which often results in errors in the final coordinate files (as evidenced by many ligand errors in entries in the PDB).

ACPYPE resulted from our need to find a solution to this problem for NMR-SC using the CNS software [5]: the simulated annealing (SA) and water refinement (WR) procedures for protein-ligand complexes require a full topological description of the ligand, including hydrogens to handle interatomic distance restraints from NMR. We first explored a host of existing solutions; unfortunately none of them generated the required topologies. CNS and XPLOR (including its variant XPLOR-NIH [6, 7]) have a function called LEARn that only generates parameter information, no topology nor charges. XPLO2D [8], one of the first tools to address the problem of generating topological parameters for small molecules, also does not calculate charges. Both approaches are not amenable for the now almost mandatory final water refinement step in an NMR structure calculation protocol. A more recent and well-known application is PRODRG [9]. However, in order to speed up calculations PRODRG uses the concept of “united-atoms” where no explicit hydrogen atoms are present, and its topologies are unsuitable for all-atom force fields and water refinement. The GlyCaNS [10] tool generates the required topological parameters in CNS format but has limited scope as it only works for polysaccharides. The MKTOP program [11] can define atom types and hence topological parameters, but it cannot derive partial charges and only recently became able to generate topologies for AMBER03 [12] force field (besides the OPLS/AA [13]). Finally, the recently developed Automated Topology Builder (ATB) [14] is limited in scope because it only generates topologies compatible with the GROMOS 53A6 [15] force field.

The tool we identified as having the most relevant functionality was ANTECHAMBER [1]. It is the main tool for creating variants in AMBER force fields [16], has foundations in quantum mechanics rather than empirical data, and is iteratively improved based on experience from previous force fields implementations. It is already used to automatically generate topologies with the General Amber Force Field (GAFF [17]), and although AMBER force fields are ported to CNS/XPLOR [5, 7], the ANTECHAMBER output has to be interpreted and converted before it becomes useful. A similar tool called CGenFF [18] generates CHARMM General Force Field topology for small molecules, but is more recent and does not have as wide a user base. We therefore chose ANTECHAMBER as the starting point for ACPYPE, with the aim to facilitate and automate its operation for non-AMBER users, as well as extending its use to other Python based applications.

ACPYPE is already successfully used in the scientific community; it is released under the open source GNU GPL version 3 license, is freely available, and offers a reliable solution for generating topologies and parameters for small chemical compounds in all-atom force fields in the following platforms: CNS/XPLOR, GROMACS and CHARMM [19]. It also automates several steps necessary to create a library for a small molecule for the AMBER package. The topologies generated by ACPYPE can be further used in AMBER force fields as ported to GROMACS (viz. ffAMBER [20]), CNS/XPLOR, NAMD [21] and CHARMM) without breaking the compatibility of the force field. ACPYPE is object oriented and uses an API library that can be easily extended, so new routines for as yet unsupported MD packages are easily added.

Methods

Implementation

ACPYPE collects information about the molecular system from the input molecular coordinate file and from the topology and parameters as generated by ANTECHAMBER and the tleap, sleap or xleap AMBER tools. It then creates a Python object where all this information is combined (see Figure 1 for a general overview). ACPYPE requires Python 2.6 (or higher) and ANTECHAMBER (version from AmberTools12 is recommended, although it should work with older versions). OpenBabel [22, 23] installation is optional but required for reading molecule information from PDB-style files. Python, ANTECHAMBER/AmberTools and OpenBabel are freely available.

ACPYPE is executed by the command ‘acpype [options]’, where the main options are:

  • · -i <filename>: An input coordinate file is required in one of the following formats: MOL2, PDB or MDL.

  • · -n [int]: This option defines the net charge of the molecule. If not given, ACPYPE will use the Gasteiger method [24] to guess the charge. This is not a dependable procedure, however, and might result in an incorrect overabundancell charge.

  • · -a [gaff | amber]: GAFF is used by default. Option ‘amber’ will use a set of parameters merged from the highly developed force fields AMBER99SB [2] for proteins and AMBER99bsc0 [25] for nucleic acids. In case a parameter is not found for AMBER99SB, ACPYPE will fall back to GAFF definitions.

  • · -c [bcc | gas | user]: The semi-empirical quantum chemistry programme SQM [26] is used by default (via ANTECHAMBER) to determine the atomic partial charges. Option ‘gas’ will use the faster but less precise Gasteiger method, option ‘user’ will take partial charges as defined in a MOL2 file, which can be calculated using more sophisticated methods like R.E.D. [27, 28] or the YASARA AutoSMILES Server [29] (see Additional file 1).

After successful execution, ACPYPE creates a folder that contains several files in different formats for the chosen MD programmes (see Figure 1). It can also fully replace the topology file converter from AMBER to GROMACS (amb2gmx[30, 31]) with some notable differences:

  • · In GROMACS, torsionals (proper and improper) are treated as Ryckaert-Bellemans potentials [32] and amb2gmx combines multiple AMBER torsions per quartet of atoms. ACPYPE in contrast separates improper from proper dihedrals, and, similarly to the ffAMBER project approach, uses the correct AMBER analytical function to treat proper dihedrals in GROMACS;

  • · ACPYPE does not depend on the ambpdb tool, which requires the AMBER proprietary package;

  • · ACPYPE reads and converts octahedron (INPCRD box) parameters to the GROMACS file. If not available, new box parameters will be calculated. It also recognises TIP3P or SPC/E water types and applies the correct parameters. This feature requires only the Python interpreter (see Figure 1) through the command: ‘acpype -p _prmtop_ -x _inpcrd_’.

Testing - ACPYPE topologies versus AMBER force field

Since ACPYPE relies on ANTECHAMBER for generating topological parameters, it was possible to use a previously published validation procedure [17]. We generated 22 PDB files with PyMOL [33], each containing a tripeptide consisting of the same single natural amino, including protonation variants for His (for more details, see Additional file 2). GROMACS 4.5, which includes now ffAMBER, was then used to generate topology files for these tripeptides with the AMBER99SB force field as reference. In all cases a single point GROMACS energy minimisation step was performed.

Testing - Small molecules from the PDB

ACPYPE (revision 275 with AmberTools 1.3) was executed on 8950 chemical components (ligands, small molecules and monomers) available from the PDB [34]. Two sets of files, one with the coordinates from the original PDB deposition and one with the ‘ideal’ CORINA coordinates [35, 36] were written out in the MOL2 format via the CcpNmr FormatConverter [37] from the PDBe database [38, 39], totalling 17900 input files. Charges were calculated using SQM with AM1-BC. The 17900 ACPYPE jobs, required a total execution time of just over 16 days on a computer using 20 AMD Opteron 2.3 GHz cores. The cut off time of execution per job was 10 hours, any job taking longer than that was killed.

Testing - NMR structure calculation

We recalculated 5 protein-ligand NMR structures using the RECOORD protocol [40]. A purpose-written Python script that integrates the ACPYPE API with the CCPN API was developed to run ACPYPE on the ligand only to generate its GAFF force field parameters. These were incorporated into the standard protein topology files to calculate 200 initial structures by simulated annealing (SA) with CNS (topology and parameters from Engh & Huber [41] ). The 50 best of these structures were water refined (WR) using the OPLSX force field, with ACPYPE again providing the GAFF parameters for the ligand only (see Discussion). The 50 final structures were sorted by overall energy and the best 25 structures were validated through the iCING [42] server, and then compared against the validation of the original NMR structures as provided by NRG-CING [43]. Double the number of default RECOORD timesteps were used during the SA and WR because of the size of the proteins and presence of ligand.

Results

We employed three tests to verify the correctness and applicability of the topologies generated by ACPYPE; to test its accuracy in transferring core data ACPYPE was compared to ffAMBER, to test its robustness ACPYPE was executed on a large set of small molecules from the PDB, and to test its usability ACPYPE-generated ligand topologies were employed to recalculate protein–ligand structures from NMR data.

ACPYPE topologies versus ffAMBER

All atom types and parameters from GROMACS’ AMBER99SB output were identical to ACPYPE with the AMBER99SB option, with the following minor differences:

  • · For histidine (all variants), arginine and tryptophan, ACPYPE generated some inverted improper dihedrals;

  • · For tryptophan ACPYPE incorporated 3 additional unnecessary (but harmless) improper dihedrals in the aromatic rings due to atom sharing;

  • · For the tyrosine CZ atom ACPYPE obtained atom type CA instead of C in GROMACS. This also results in parameter differences for 6 bonds and 9 dihedrals.

  • · The partial atom charges parameters differ.

Despite these changes, the difference in total bonded potential energy (i.e. without the long distance terms that depends on charges) for the 22 systems is very small between the ffAMBER and ACPYPE sets; the highest difference occurs for the tyrosine tripeptide and is 1.9% (6.7 kJ/mol). This is because of the the aforementioned atom type change and its consequent parameter modifications for bonds and dihedrals. For all other tripeptides, the difference is never higher than 0.002%. To further confirm that ACPYPE gives consistent results, we used the validation methodology by Eric Sorin and collaborators for ffAMBER [44] and compared the results from the AMBER11 MD engine (programme sander) to the results from GROMACS with ACPYPE topologies. For all systems except tyrosine, using the same set of charges as defined in the AMBER99SB force field, the total potential energy differences were always inferior to 0.007%. Tyrosine again was the outlier, but with a total potential energy difference <3%.

Small molecules from the PDB

This test on 8950 small molecules served to evaluate the robustness of ACPYPE and debug the code. The first step was to curate the initial set of 8950 small molecule entries; since the information from the PDB is not always correct and the data went through a conversion process to generate the input files, entries with issues varying from total absence of input files to wrong atom coordinates were removed. Entries were also removed from further analysis if they did not adhere to a set of simple atom distance criteria (a 0.5 Å cut-off for minimum and a 3.0 Å cut-off for maximum distance between covalently bound atoms). From 17900 possible jobs (2 jobs for each PDB, one with original PDB coordinates and other with CORINA recalculated coordinates), 318 (1.78%) did not have MOL2 input files and could not be calculated, while 557 (3.11%) had erroneous atom coordinates. In total 13045 jobs (72.88%) concluded without any remarkable problems with an average execution time of 14m35s. Excluding the jobs with incorrect data the ACPYPE efficiency was 76.62% (13045 of 17025 valid jobs). For a detailed report, please see Additional file 3.

To further explore whether the generated coordinates were correct or acceptable, we selected only entries with results from ACPYPE for both the PDB and CORINA coordinates. The resulting 5772 entries (11544 jobs) were subjected to 250 steps of energy minimisation via the conjugate gradient method using CNS (version 1.2). In total 1292 jobs failed the optimisation procedure because of mixed upper and lower case atom names, which CNS does not support. This occurred because ANTECHAMBER converts upper-case names to capitalised names (e.g., bromine code ‘BR’ to ‘Br’); the issue was reported to ANTECHAMBER developers and is remedied in ACPYPE revision 285. For the remaining 10252 structures the all-atom RMSD between the initial and final structures was calculated (Figure 2) to illustrate the accuracy of the ACPYPE results.

Figure 2
figure 2

RMSD distribution. RMSD distribution for a total of 5126 entries (with two results each) after energy minimisation done with CNS programme. The average RMSD is shown by the bold vertical line.

NMR structure calculation

To test how ACPYPE works in a real NMR structure calculation setting, we used the data for 5 protein–ligand complexes from the PDB (see Table 1) that have NMR constraint data in CCPN format from the NMR Restraints Grid [43]. The results of the structure calculation are similar; overall the RMSD tends to increase for the recalculated structures, but the NOE completeness and overall quality tends to increase (Table 1). These changes are expected due to differences in the structure calculation protocol, and are also observed in the RECOORD project [40]. More importantly, this test shows that ACPYPE allows the structure determination of protein–ligand complexes with autogenerated parameters and topologies (for illustrative purposes, the structures for [PDB:1BVE] are shown in Figure 3, the other structures are available in Additional file 4).

Table 1 Original NMR x ACPYPE
Figure 3
figure 3

Recalculated entry [PDB:1BVE] Entry [PDB:1BVE] from PDB recalculated using RECOORD protocol showing 25 models superimposed; picture created with VMD [[45]].

Discussion

The idea of adapting ANTECHAMBER or its routines to derive topologies and parameters for small molecules is not new. We know of at least two cases: YASARA AutoSMILES [29] is implemented for YASARA [46], but is restricted to this commercial software package; the programme topolbuild is developed by Bruce D. Ray (personal communication), and generates topologies and parameters from a MOL2 file (with known charges) by using AMBER, GROMOS [47] or OPLS/AA [13] force fields in GROMACS format. It is limited to GROMACS and not able to generate charges.

ACPYPE has the advantage that it avoids these limitations. Moreover, ACPYPE is written in Python and makes the (converted) information from ANTECHAMBER easily accessible for integration in other projects. In the NMR community, it is already availabel via CCPN [48], and it will be used in the upcoming rehash of the RECOORD structure recalculation project [40], where complexes will be included in addition to monomers. Pilot integration with ARIA2 [49], in order to make it work seamlessly via the CcpNmr Grid portal [50], was also tested. In the MD community, ACPYPE is used in the DrugDiscovery@Home project [51], and it is employed by others (for example, see [52]). We also intend to further verify ACPYPE based on http://virtualchemistry.org[53], a recent database of 145 organic molecules with some physical properties calculated and topologies for GAFF [17] and OPLS/AA validated by using the GROMACS software [54].

Since ACPYPE is based on ANTECHAMBER, it also inherits some of its core limitations: it is not possible to work with organic molecules with open valences; it cannot handle atoms besides C, N, O, S, P, H, F, Cl, Br and I; and there cannot be any covalent bonds to another (non-defined) molecule. Some of these restrictions can be circumvented: for example if one wants parameters for a modified amino acid residue, it is possible to neutralise the N- and C- termini and then fit the additional parameters manually to the modified residue.

The topological parameters generated by ACPYPE are based on GAFF or AMBER99SB and should be used only with compatible force fields such as AMBER and its variants; when employing ACPYPE to generate the ligand for a protein–ligand complex, the force field parameters for the protein should be from the AMBER family. However, it is possible to use CNS with topologies generated by ACPYPE, even if this means mixing two different force fields (Engh & Huber [41] and AMBER99SB/GAFF). This can be justified because during the SA steps of a structure calculation the values of all parameters are increased to much higher and fixed thresholds, and are so equalised for both protein and ligands. Essentially the topology information remains the same and all parameters are flattened (the GAFF or AMBER99SB parameters are overwritten by those from Engh & Huber), so the SA in CNS can be performed without problems, as illustrated by the protein-ligand case studies presented here. Likewise, during WR steps, the protein is described by OPLSX parameters (which are close to the original OPLS parameters and do not introduce new atom types), with identical topology description and very similar parameters to those used in the AMBER force field family.

Another point for consideration is the way improper dihedrals are defined in AMBER force fields. They are a set of “proper” dihedrals that act only in planes, which may result in chirality inversions or peptide bond flips during the high-temperature portions of SA runs. This problem is treated in AMBER MD applications by adding chirality constraints and trans-peptide ω constraints (where appropriate), but this solution is not easily extended to other MD programmes. However, since we use AMBER force fields only for small molecules, this is only a problem if the molecule has defined chiral centres. Where necessary it is possible to implement a routine to check the chiral centres every few steps using the CNS macro language, or to implement an extra step where the improper dihedrals are introduced in the ACPYPE generated topologies before the calculation. Although ACPYPE will work automatically in many cases, it is not recommended to use it as a “black box”, and one should always explore the molecule under investigation as well as the force field(s) used for parameterisation.

During the development of ACPYPE, some issues in AmberTools (with ANTECHAMBER in particular) were spotted, identified and reported back to their developers, sometimes with a proposed solution. This procedure only enriched the quality of both programmes, and emphasises the strength of working with open-source projects. Moreover, in relation to GROMACS, an open-source MD application, ACPYPE has great potential for usability and further development. ACPYPE is in constant development and has already a measurable community of users and contributors with ideas of extending it for other MD and NMR-SC programmes.

Conclusions

ACPYPE is an ANTECHAMBER-based tool that fills the current gap in software to automatically incorporate small molecules in MD and NMR-SC. It calculates partial charges and generates topology and parameters in different formats for different MM programmes, while being object oriented for integration with other applications. It is a robust and flexible application, completely open source and freely available online for use by the scientific community.

Availability and requirements

· Project name: ACPYPE - AnteChamber PYthon Parser interfacE

· Home page:http://www.ccpn.ac.uk/acpype

· Operating Systems: Platform independent

· Programming language: Python

· Other requirements: Python 2.6 or higher, including Python 3.x; Antechamber 1.27 or (preferably) AmberTools 1.0 or higher; (optional, but strongly recommended) Open Babel 2.2.0 or higher

· License: GNU GPL version 3

Abbreviations

ACPYPE:

AnteChamber PYthon Parser interfacE

GAFF:

General Amber Force Field

MD:

Molecular Mechanics

NMR-SC:

Nuclear Magnetic Resonance Structure Calculation

SA:

Simulated Annealing

WR:

Water Refinement.

References

  1. Wang J, Wang W, Kollman PA, Case DA: Automatic atom type and bond type perception in molecular mechanical calculations. J Mol Graphics Model. 2006, 25 (2): 247-260. 10.1016/j.jmgm.2005.12.005.

    Article  Google Scholar 

  2. Hornak V, Abel R, Okur A, Strockbine B, Roitberg A, Simmerling C: Comparison of multiple Amber force fields and development of improved protein backbone parameters. Proteins: Struct, Funct, Bioinf. 2006, 65 (3): 712-725. 10.1002/prot.21123.

    Article  CAS  Google Scholar 

  3. 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: 235-242. 10.1093/nar/28.1.235. [http://www.pdb.org].

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  4. Klepeis JL, Lindorff-Larsen K, Dror RO, Shaw DE: Long-timescale molecular dynamics simulations of protein structure and function. Curr Opin Struct Biol. 2009, 19 (2): 120-127. 10.1016/j.sbi.2009.03.004.

    Article  PubMed  CAS  Google Scholar 

  5. Brunger AT: Version 1.2 of the Crystallography and NMR System. Nature Protoc. 2007, 2 (11): 2728-2733. 10.1038/nprot.2007.406.

    Article  CAS  Google Scholar 

  6. Schwieters CD, Kuszewski JJ, Tjandra N, Clore GM: The Xplor-NIH NMR molecular structure determination package. J Magn Reson. 2003, 160: 65-73. 10.1016/S1090-7807(02)00014-9.

    Article  PubMed  CAS  Google Scholar 

  7. Schwieters CD, Kuszewski JJ, Clore GM: Using Xplor-NIH for NMR molecular structure determination. Prog Nucl Magn Reson Spectrosc. 2006, 48: 47-62. 10.1016/j.pnmrs.2005.10.001.

    Article  CAS  Google Scholar 

  8. Kleywegt GJ, Henrick K, Dodson E, van Aalten DMF: Pound-wise but penny-foolish: How well do micromolecules fare in macromolecular refinement?. Structure. 2003, 11 (9): 1051-1059. 10.1016/S0969-2126(03)00186-2.

    Article  PubMed  CAS  Google Scholar 

  9. Schüttelkopf AW, van Aalten DMF: PRODRG: A tool for high-throughput crystallography of protein-ligand complexes. Acta Crystallogr Sect D - Biol Crystallogr. 2004, 60 (8): 1355-1363. 10.1107/S0907444904011679.

    Article  Google Scholar 

  10. Krzeminski M, Bonvin AMJJ: The GlyCaNS toolbox and web server for the generation of complex oligosaccharide models and topologies. [http://haddock.chem.uu.nl/glycans].[Tobesubmitted].

  11. Ribeiro AAST, Horta BAC, de Alencastro RB: MKTOP: A program for automatic construction of molecular topologies. J Braz Chem Soc. 2008, 19 (7): 1433-1435. 10.1590/S0103-50532008000700031.

    Article  CAS  Google Scholar 

  12. Duan Y, Wu C, Chowdhury S, Lee MC, Xiong G, Zhang W, Yang R, Cieplak P, Luo R, Lee T, Caldwell J, Wang J, Kollman PA: A point-charge force field for molecular mechanics simulations of proteins based on condensed-phase quantum mechanical calculations. J Comput Chem. 2003, 24 (16): 1999-2012. 10.1002/jcc.10349.

    Article  PubMed  CAS  Google Scholar 

  13. Jorgensen WL, Maxwell DS, Tirado-Rives J: Development and testing of the OPLS all-atom force field on conformational energetics and properties of organic liquids. J Am Chem Soc. 1996, 118 (45): 11225-11236. 10.1021/ja9621760.

    Article  CAS  Google Scholar 

  14. Malde AK, Zuo L, Breeze M, Stroet M, Poger D, Nair PC, Oostenbrink C, Mark AE: An Automated Force Field Topology Builder (ATB) and Repository: Version 1.0. J Chem Theory Comput. 2011, 7 (12): 4026-4037. 10.1021/ct200196m. [http://compbio.biosci.uq.edu.au/atb].

    Article  PubMed  CAS  Google Scholar 

  15. Oostenbrink C, Villa A, Mark A, Van Gunsteren W: A biomolecular force field based on the free enthalpy of hydration and solvation: The GROMOS force-field parameter sets 53A5 and 53A6. J Comput Chem. 2004, 25 (13): 1656-1676. 10.1002/jcc.20090.

    Article  PubMed  CAS  Google Scholar 

  16. Ponder JW, Case DA: Force fields for protein simulations. Adv Protein Chem. 2003, 66: 27-85.

    Article  PubMed  CAS  Google Scholar 

  17. Wang J, Wolf RM, Caldwell JW, Kollman PA, Case DA: Development and testing of a General Amber Force Field. J Comput Chem. 2004, 25 (9): 1157-1174. 10.1002/jcc.20035.

    Article  PubMed  CAS  Google Scholar 

  18. Vanommeslaeghe K, Hatcher E, Acharya C, Kundu S, Zhong S, Shim J, Darian E, Guvench O, Lopes P, Vorobyov I, Mackerell Jr AD: 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.

    PubMed  CAS  PubMed Central  Google Scholar 

  19. Brooks BR, Brooks III CL, MacKerell Jr AD, Nilsson L, Petrella RJ, Roux B, Won Y, Archontis G, Bartels C, Boresch S, Caflisch A, Caves L, Cui Q, Dinner AR, Feig M, Fischer S, Gao J, Hodoscek M, Im W, Kuczera K, Lazaridis T, Ma J, Ovchinnikov V, Paci E, Pastor RW, Post CB, Pu JZ, Schaefer M, Tidor B, Venable RM, Woodcock HL, Wu X, Yang W, York DM, Karplus M: CHARMM: The Biomolecular Simulation Program. J Comput Chem. 2009, 30 (10): 1545-1614. 10.1002/jcc.21287.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  20. Sorin EJ, Pande VS: Exploring the helix-coil transition via all-atom equilibrium ensemble simulations. Biophys J. 2005, 88 (4): 2472-2493. 10.1529/biophysj.104.051938.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  21. Phillips JC, Braun R, Wang W, Gumbart J, Tajkhorshid E, Villa E, Chipot C, Skeel RD, Kalé L, Schulten K: Scalable molecular dynamics with NAMD. J Comput Chem. 2005, 26 (16): 1781-1802. 10.1002/jcc.20289.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  22. Guha R, Howard MT, Hutchison GR, Murray-Rust P, Rzepa H, Steinbeck C, Wegner JK, Willighagen EL: The Blue Obelisk–Interoperability in chemical informatics. J Chem Inf Model. 2006, 46 (3): 991-998. 10.1021/ci050400b.

    Article  PubMed  CAS  Google Scholar 

  23. Open Babel. [http://www.openbabel.org].

  24. Gasteiger J, Marsili M: New model for calculating atomic charges in molecules. Tetrahedron Lett. 1978, 19 (34): 3181-3184. 10.1016/S0040-4039(01)94977-9.

    Article  Google Scholar 

  25. Pérez A, Marchán I, Svozil D, Sponer J, Cheatham III TE, Laughton CA, Orozco M: Refinement of the AMBER force field for nucleic acids: improving the description of α/γ conformers. Biophysical Journal. 2007, 92 (11): 3817-3829. 10.1529/biophysj.106.097782.

    Article  PubMed  PubMed Central  Google Scholar 

  26. Walker RC, Crowley MF, Case DA: The implementation of a fast and accurate QM/MM potential method in Amber. J Comput Chem. 2008, 29 (7): 1019-1031. 10.1002/jcc.20857.

    Article  PubMed  CAS  Google Scholar 

  27. Dupradeau FY, Cézard C, Lelong R, Stanislawiak É, Pêcher J, Delepine JC, Cieplak P: R.E.DD.B: A database for RESP and ESP atomic charges, and force field libraries. Nucleic Acids Res. 2008, 36 (Database issue): D360-D367.

    PubMed  CAS  PubMed Central  Google Scholar 

  28. RESP ESP charge Derive Home Page. [http://www.q4md-forcefieldtools.org].

  29. YASARA AutoSMILES. [http://www.yasara.org/autosmiles].

  30. Mobley DL, Chodera JD, Dill KA: On the use of orientational restraints and symmetry corrections in alchemical free energy calculations. J Chem Phys. 2006, 125 (8): 084902-1–084902–16. 10.1063/1.2221683.

    Article  PubMed  PubMed Central  Google Scholar 

  31. ffAMBER Tool amb2gmx. [http://amber.cnsm.csulb.edu/tools.html].

  32. Ryckaert JP, Bellemans A: Molecular-Dynamics of liquid alkanes. Faraday Discuss Chem Soc. 1978, 66: 95-106.

    Article  Google Scholar 

  33. DeLano WL: The PyMOL Molecular Graphics System. 2002, Palo Alto, CA, USA, [http://www.pymol.org].

    Google Scholar 

  34. Berman H, Henrick K, Nakamura H, Markley JL: The worldwide Protein Data Bank (wwPDB): ensuring a single, uniform archive of PDB data. Nucleic Acids Res. 2007, 35: D301-D303. 10.1093/nar/gkl971.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  35. Sadowski J, Gasteiger J, Klebe G: Comparison of Automatic Three-Dimensional Model Builders Using 639 X-ray Structures. J Chem Inf Comput Sci. 1994, 34 (4): 1000-1008. 10.1021/ci00020a039.

    Article  CAS  Google Scholar 

  36. The 3D structure generator CORINA. [http://www.molecular-networks.com].

  37. Vranken WF, Boucher W, Stevens TJ, Fogh RH, Pajon A, Llinás M Miguel, Ulrich EL, Markley JL, Ionides J, Laue ED: The CCPN data model for NMR spectroscopy: Development of a software pipeline. Proteins: Struct, Funct, Bioinf. 2005, 59 (4): 687-696. 10.1002/prot.20449.

    Article  CAS  Google Scholar 

  38. Velankar S, Best C, Beuth B, Boutselakis CH, Cobley N, Sousa da Silva AW, Dimitropoulos D, Golovin A, Hirshberg M, John M, Krissinel EB, Newman R, Oldfield T, Pajon A, Penkett CJ, Pineda-Castillo J, Sahni G, Sen S, Slowley R, Suarez-Uruena A, Swaminathan J, van Ginkel G, Vranken WF, Henrick K, Kleywegt GJ: PDBe: Protein Data Bank in Europe. Nucleic Acids Res. 2010, 38 (Database issue): D308-D317.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  39. Velankar S, Alhroub Y, Alili A, Best C, Boutselakis HC, Caboche S, Conroy MJ, Dana JM, van Ginkel G, Golovin A, Gore SP, Gutmanas A, Haslam P, Hirshberg M, John M, Lagerstedt I, Mir S, Newman LE, Oldfield TJ, Penkett CJ, Pineda-Castillo J, Rinaldi L, Sahni G, Sawka G, Sen S, Slowley R, Sousa da Silva AW, Suarez-Uruena A, Swaminathan GJ, Symmons MF, Vranken WF, Wainwright M, Kleywegt GJ: PDBe: Protein Data Bank in Europe. Nucleic Acids Res. 2011, 39 (Database issue): D402-D310.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  40. Nederveen AJ, Doreleijers JF, Vranken W, Miller Z, Spronk CAEM, Nabuurs SB, Güntert P, Livny M, Markley JL, Nilges M, Ulrich EL, Kaptein R, Bonvin AMJJ: RECOORD: A recalculated coordinate database of 500+proteins from the PDB using restraints from the BioMagResBank. Proteins: Struct, Funct, Bioinf. 2005, 59 (4): 662-672. 10.1002/prot.20408.

    Article  CAS  Google Scholar 

  41. Engh RA, Huber R: Accurate bond and angle parameters for X-ray protein structure refinement. Acta Crystallogr Sect A. 1991, 47 (4): 392-400. 10.1107/S0108767391001071.

    Article  Google Scholar 

  42. Doreleijers JF, Sousa da Silva AW, Krieger E, Krieger E, Nabuurs SB, Spronk CAEM, Stevens TJ, Vranken WF, Vriend G, Vuister GW: CING; an integrated residue-based structure validation program suite. [http://nmr.cmbi.ru.nl/cing].[SubmittedtoJournalofBiomolecularNMR].

  43. Doreleijers JF, Vranken WF, Schulte C, Lin J, Wedell JR, Penkett CJ, Vuister GW, Vriend G, Markley JL, Ulrich EL: The NMR restraints grid at BMRB for 5,266 protein and nucleic acid PDB entries. J Biomol NMR. 2009, 45 (4): 389-396. 10.1007/s10858-009-9378-z.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  44. ffAMBER Implementation & Validation. [http://amber.cnsm.csulb.edu/#validation].

  45. Humphrey W, Dalke A, Schulten K: VMD: Visual Molecular Dynamics. J Mol Graphics. 1996, 14: 33-38. 10.1016/0263-7855(96)00018-5.

    Article  CAS  Google Scholar 

  46. Krieger E, Koraimann G, Vriend G: Increasing the precision of comparative models with YASARA NOVA - a self-parameterizing force field. Proteins: Struct, Funct, Bioinf. 2002, 47 (3): 393-402. 10.1002/prot.10104.

    Article  CAS  Google Scholar 

  47. Schuler L, Daura X, van Gunsteren W: An improved GROMOS96 force field for aliphatic hydrocarbons in the condensed phase. J Comput Chem. 2001, 22 (11): 1205-1218. 10.1002/jcc.1078.

    Article  CAS  Google Scholar 

  48. Fogh RH, Boucher W, Vranken WF, Pajon A, Stevens TJ, Bhat TN, Westbrook J, Ionides JMC, Laue ED: A framework for scientific data modeling and automated software development. Bioinformatics. 2005, 21 (8): 1678-1684. 10.1093/bioinformatics/bti234.

    Article  PubMed  CAS  Google Scholar 

  49. Rieping W, Habeck M, Bardiaux B, Bernard A, Malliavin TE, Nilges M: ARIA2: Automated NOE assignment and data integration in NMR structure calculation. Bioinformatics. 2007, 23 (3): 381-382. 10.1093/bioinformatics/btl589.

    Article  PubMed  CAS  Google Scholar 

  50. CcpNmr Grid Portal. [http://webapps.ccpn.ac.uk/ccpngrid].

  51. DrugDiscovery@Home. [http://drugdiscoveryathome.com].

  52. Yoneya M: A practical guide to molecular simulation of liquid crystals. J Jpn Liq Cryst Soc: EKISHO. 2009, 13 (3): 219-228. [http://staff.aist.go.jp/makoto-yoneya/MDforEKISHO/ekisho09July/ekisho09July2.html]. [InJapanesebutGooglecanperformafairautomatictranslation].

    CAS  Google Scholar 

  53. van der Spoel D, van Maaren PJ, Caleman C: GROMACS molecule & liquid database. Bioinformatics. 2012, 28 (5): 752-753. 10.1093/bioinformatics/bts020. [http://virtualchemistry.org].

    Article  PubMed  CAS  Google Scholar 

  54. Hess B, Kutzner C, van der Spoel D, Lindahl E: GROMACS 4: Algorithms for highly efficient, load-balanced, and scalable molecular simulation. J Chem Theory Comput. 2008, 4 (3): 435-447. 10.1021/ct700301q.

    Article  PubMed  CAS  Google Scholar 

Download references

Acknowledgements

The authors thank the existing users of ACPYPE for their invaluable feedback, Prof. Dr. E. D. Laue for providing the financial support for AWSdS and for supervising the project, and Drs. T. Stevens and W. Boucher for help with integration with the CCPN software and the development of the ACPYPE web server. This project was funded through grants to EDL (BBSRC grant BB/D006384/1; and the EU FP6 Extend-NMR project, grant 18988), from the CCPN industrial funds and equipment at the PDBe by the Wellcome Trust (grants 088944 and 075968). WFV was supported by both the Extend-NMR project and the FP7 e-NMR project (grant 213010)

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Alan W Sousa da Silva.

Additional information

Competing interests

Both authors declare that they do not have any competing interests.

Authors’ contributions

AWSdS developed the software, carried out most of the testing and analysed the results. WFV provided input and test data, performed basic testing, and helped with the analysis of results. AWSdS wrote the manuscript with continuous support from WFV. Both authors read and approved the final manuscript version.

Electronic supplementary material

Authors’ original submitted files for images

Below are the links to the authors’ original submitted files for images.

Authors’ original file for figure 1

Authors’ original file for figure 2

Authors’ original file for figure 3

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Sousa da Silva, A.W., Vranken, W.F. ACPYPE - AnteChamber PYthon Parser interfacE. BMC Res Notes 5, 367 (2012). https://doi.org/10.1186/1756-0500-5-367

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1756-0500-5-367

Keywords