Abstract
In this paper, we present dSASA (differentiable SASA), an exact geometric method to calculate solvent accessible surface area (SASA) analytically along with atomic derivatives on GPUs. The atoms in a molecule are first assigned to tetrahedra in groups of four atoms by Delaunay tetrahedrization adapted for efficient GPU implementation and the SASA values for atoms and molecules are calculated based on the tetrahedrization information and inclusion-exclusion method. The SASA values from the numerical icosahedral-based method can be reproduced with more than 98% accuracy for both proteins and RNAs. Having been implemented on GPUs and incorporated into the software Amber, we can apply dSASA to implicit solvent molecular dynamics simulations with inclusion of this nonpolar term. The current GPU version of GB/SA simulations has been accelerated up to nearly 20-fold compared to the CPU version, outperforming LCPO, a commonly used, fast algorithm for calculating SASA, as the system size increases. While we focus on the accuracy of the SASA calculations for proteins and nucleic acids, we also demonstrate stable GB/SA MD mini-protein simulations.
Introduction
An accurate description of the solvent environment is essential for biomolecular modeling, as biological machines are functioning in an aqueous environment. The solute-solvent interactions and the rearrangement of water molecules induce the change of molecular shapes and the solvation free energy .1 Including water molecules in explicit solvent simulations produces more accurate simulation results at the cost of redundant calculation for the pairwise interactions between water molecules, while the friction induced by collisions with water molecules can further slow down the conformational sampling of the solute. In implicit solvent models, the solvent is treated as a continuum and the system is simulated without explicit water molecules. The major advantage of implicit solvent models is the ability to explore the conformational space more efficiently, which can find applications in protein folding studies and structure prediction,2,3 solvation free energy calculation using Poisson-Boltzmann surface area (PBSA)4 or generalized Born surface area (GBSA),5 and binding free energy calculation using molecular mechanics Poisson-Boltzmann surface area (MM-PBSA).6
In implicit solvent modeling, the solvation free energy can be decomposed into polar and nonpolar contributions7 and the expression is
where the polar term gives the difference between the work of uncharging the solute in vacuum and the work of charging the solute in solvent, denotes the accommodation of cavity in the solvent for solute and represents the van der Waals interactions between solute and solvent. The Poisson-Boltzmann (PB) method describes the electrostatic potential in solution for a given set of boundary conditions and determines the effect of electrostatic interactions on the molecules8 and can be used to compute . The and are usually combined into one nonpolar term . It is considered to be proportional to the number of atoms in the solute having direct contact with solvent molecules and can be estimated in terms of the solvent accessible surface area (SASA).9 Although it has been pointed out that incorporation of the volume term into the computation can provide a more complete description of the nonpolar contribution, 10,11 the surface area based methods can still have good performance in the prediction of the native-like conformations of proteins and the estimation of ligand-binding affinities. 12
In implicit solvent molecular dynamics (MD) simulations, most of the effort has been devoted to the development of the dominant polar part. Due to the complexity of solving the PB equation, the generalized Born (GB) method5 was proposed to approximate the solution of the PB equation with simple functional forms. The recent improvement of fast GB models for proteins13–15 and nucleic acids16 and its implementation on graphics processing units (GPUs)17 helped GB achieve popularity in recent years. The main goal of a GB model is to achieve agreement of electrostatic free energies with the PB approach, which can be achieved by parametrizing the GB screening parameters to provide a better match of the effective radii to those from the reference method. In particular, the pairwise decomposition version of GB18 is ideal for implementation on GPU with parallel computing. Although the performance of GB is improving, poor folding stabilities were observed in protein folding studies,2 structure predictions3 and de novo designed peptides with high helicity.19 As hypothesized in, 2 the neglected nonpolar solvation term might result in instability; this was supported by improved fold stability when an approximate SASA-based nonpolar term was added to the same GB model.20 As shown in that paper, the inclusion of the nonpolar term in the GB/SA MD simulations can produce more stable trajectories and better simulated melting temperatures than comparable simulations with identical setup other than the SASA term.
There exist several methods to calculate the molecular surface area on CPUs and GPUs. However, only a few of them can be applied to MD simulations because most of them lack reliable derivatives for atoms. The solvent accessible surface was proposed by Lee and Richards.21 A numerical implementation by Connolly22 is computationally expensive and lacks analytical derivatives. The derivatives are unreliable or unavailable in other methods, such as grid based, neighbor-counting or machine learning.23 The approximation methods on GPU have similar issues.24,25 In the CHARMM software, GBMV2/SA26 can reproduce the molecular surface and has been implemented on GPUs.27 However, the computation is based on grid points so lower resolution of the grids may generate less reliable results while higher resolution results in slower simulation speed. The first available method for approximating surface area along with derivatives in Amber is LCPO28 which is able to estimate SASA based on the neighbors of atoms. As the MD simulations in Amber are now primarily on GPUs,17,29 the data transfer between CPU and GPU deteriorates the performance because LCPO is implemented only on CPUs. Recently, another approximate pairwise method with a faster speed (up to 30 times faster), called pwSASA, was proposed and it achieved a comparable accuracy to LCPO according to the testing of proteins.20 The main purpose of pwSASA was to investigate the impact of the nonpolar term on the MD simulations of proteins with a simple and fast pairwise approximation suitable for running entirely on GPUs. The simple form of the functions provided faster simulation speed and did prove the significance of nonpolar term in the simulations. However, the computed SASA values had various correlation coefficients from 0.6 to 0.9 compared with the numerical computation for a number of proteins, which is partly because the higher order interactions were ignored. Furthermore, pwSASA is highly empirical, and the parameters were trained only for the specific local atomic environments founds in amino acids (such as hybridization and the identity of bound atoms). Thus in addition to relatively low accuracy on proteins, pwSASA cannot be used in simulations of more diverse systems such as those including modified amino acids, small molecule ligands, nucleic acids, or glycans, further limiting its suitability.
As every atom in a molecule can be represented by a sphere, the surface areas have also been studied by computational geometry methods. One reliable and accurate method was developed based on the Alpha Complex construction30 by which the geometric descriptors of molecules can be computed through union of balls. The Alpha Complex is obtained with the atomic coordinates and radii information and can be applied to decompose the space into small segments through which the surface areas are computed by using Gauss-Bonnet theorem31 or inclusion-exclusion formulas.32–34 Recently, the extension to other geometric measures, such as volumes, mean and Gaussian curvatures, was proposed35 in which the parallel implementation can achieve speed improvement over the serial version. However, the full implementation of such method on GPUs is still unavailable because each step in the method requires substantial effort to utilize the parallel computing property to improve performance.
Here we present dSASA, a new method to calculate SASA and its derivatives with respect to atomic coordinates using Alpha Complex theory and inclusion-exclusion method. This fully analytical and accurate algorithm has been implemented on GPUs and incorporated in Amber software. The basic background and the procedures employed in the method will be first shown. The results for the assessment of the method are next given: the accuracy of estimation is examined by several protein systems with diverse topologies, the speed of the GPU version in GB/SA simulations is compared with the CPU version and other methods, and the performance is demonstrated by including this nonpolar term in GB/SA simulations on proteins. However, we caution readers that good practice in force field development involves isolation and validation of the individual components as done here. Deviations from experimental behavior can arise from inaccuracy in any of the multiple components (solute force field, polar solvation term, and nonpolar term). Likewise, a good match to experiment can be obtained from fortuitous cancellation of error. For this reason, we show that the dSASA term performs well in MD simulations, which verifies the efficient algorithm implementation, but our main focus remains on validating the SASA accuracy.
Methods
Theory and estimations for nonpolar solvation
In the implicit solvent model, the nonpolar solvation term is usually SASA-based. 5 The free energy is proposed to be proportional to SASA with a surface tension parameter . The surface tension is assumed to be identical for all atoms.
The relatively accurate SASA values can be calculated by ICOSA numerical method36 ( in Amber), in which starting from an icosahedron a water probe with radius 1.4 Å is recursively rolled on the van der Waals surface of the molecule. The implementation of this method in current Amber MD simulations is unavailable because of the absence of atomic forces. The Linear Combinations of Pairwise Overlaps (LCPO; in Amber) is the first stable algorithm used in GB/SA MD simulations in Amber. The neighbor list of a central atom is used to subtract the pairwise overlapping from its isolated sphere areas, which results in the computation complexity , where is the total number of solute atoms, so it will slow down quadratically as the size of the molecule increases. In the GPU version of GB/SA MD with this method, the data transfer between CPU and GPU decelerates the simulations as its implementation is CPU/GPU hybrid. The pairwise approximation of SASA (pwSASA; in Amber)20 is the recently developed algorithm to calculate SASA that is suitable for implementing on GPUs. The idea is similar to LCPO but only considers the interactions between two atoms, which achieves a faster speed but results in an approximate SASA. The parameters for the atom types are trained exclusively on standaard amino acids, so the application to other systems, such as nucleic acids or small molecules, is unavailable.
dSASA: an analytical method for SASA
Here we introduce , a geometric method ( in Amber) to compute SASA. As has been explored in,28,37 to be consistent with other methods, we assume that the heavy atoms in molecules can have a good approximation to the molecular SASA, reducing computational cost substantially. The atomic radii for four common elements (C, 1.7 Å;O, 1.5 Å; N, 1.55 Å; S, 1.8 Å) are used in ICOSA, pwSASA and DSASA, while LCPO is using different radii (C, 1.7 Å; O, 1.6 Å; N, 1.65 Å;S, 1.9 Å). Every atom can be represented by a weighted point in the point set , which contains the 3D coordinates in space and one point weight . The radius of water probe is set to , and the weight . Here we present the key steps, while a complete description of the analytical development of the method is given in.33,34 The method has three main steps and the depiction of the method is shown in Figure 1.
Step 1. Calculate the 3D weighted Delaunay Tetrahedrization (wDT) of all points through which the points are assigned into tetrahedra. This step has computation complexity and is the dominating part of the method.
Step 2. Create and classify the dual complex which denotes the possible interactions among close atoms. The complex contains the lists of simplices, such as the vertices (the atoms), edges (overlap between two atoms), triangles (overlap among three atoms) and tetrahedra (overlap among four atoms) from the tetrahedrization. These simplices are then filtered and classified into interior and exterior (denoted by ) based on their connection information.
Step 3. Compute the surface areas using Laguerre intersection cells and inclusion-exclusion method based on the exterior simplices .
In the following, we show the process to compute the atomic SASA based on the exterior simplices because only the atoms having direct contact with solvent contribute to the surface areas. The simplices have been classified into interior and exterior at Step 2. The Laguerre diagram of the point set is conjugate to the wDT. The space can be decomposed into cells by the conjugated Laguerre diagram as shown in Figure 1. The Laguerre cell for a weighted point (atom) is defined by
Every weighted point can also be treated as a ball , and the union of these balls forms the space filling model of . As shown in Figure 1, the Laguerre cells of exterior atoms can be unbounded or larger than the real size of the atoms, then a more realistic representation for an atom is given by the Laguerre-intersection cell, the intersection part of the Laguerre cell and the ball: . The boundary area of the Laguerre intersection part of an exterior atom is the SASA value .
Suppose there are points in a subset . The number of points in is and the centers of points are denoted by . The convex hull (conv) of points in is written as , and the term is the surface area of the intersection of the balls in . By applying the inclusion-exclusion method shown in Figure 2, the SASA of the molecule is
The coefficients are given by the corresponding simplices. When , i.e. a vertex is the fraction of the ball outside the tetrahedra in is the normalized outer solid angle subtended by the union of tetrahedra in containing . When , i.e. an edge is normalized outer dihedral angle of the union of tetrahedra in which contain the edge . When , i.e. a triangle or 0.5 is the fraction of that is outside the union of tetrahedra in . Here , and .
The contribution of individual atom to the molecular surface area is
(1) |
where is the contribution of to , and .
Then the corresponding derivative for the points can be obtained on the basis of the atomic surface area with respect to the atomic coordinates in the molecule as
(2) |
The terms in the equations are calculated as follows. When , . Let be the set of tetrahedra in to which the point belongs to. For define as the normalized inner solid angle subtended by the tetrahedron from the point . Then
(3) |
The normalized inner solid angle, , of a tetrahedron subtended by the vectors , , and is shown in the left of Figure 3 and given by the equation
where is the length of and likewise for and .
When , the intersection of two atoms , is shown in Figure 2. . Let be the set of tetrahedra in containing the edge . For define as the normalized inner dihedral angle of along . Then
The normalized inner dihedral angle between planes and with normals and is shown in the left of Figure 3 and given by
(4) |
Then the derivative terms for Eq.(2) are
(5) |
When , consider . The surface area of the common intersection of three balls can be written as a weighted sum of the surface area of the single and double intersections. If , , have a non-empty intersection then there are two points in common with the surfaces of all three balls, shown in the right of Figure 3. Denote one of the two points , define , and let . Let be the set of edges defined by and the set of vertices in . The atomic surface area of from the intersection of , , is given by
(6) |
where is the normalized dihedral angle of along the edge , is the normalized solid angle of subtended from and similarly for other combinations , , . The derivative of this term is
(7) |
By substituting Eqs. (3), (4), (5), (6) and (7) into Eqs. (1) and (2), we can obtain the surface area and the derivative for every atom. More details of the description and the equations can be found in33,34. However, the atomic derivatives may become discontinuous when atoms are approaching. Through detailed analysis in, 33 it can be seen that most common type of discontinuities occur when two atoms become externally tangent. We examine here the simplest case where only two atoms with extended radii , are considered to show the possible singularity in the calculation. The changing process of the SASA values and the atomic derivatives is given in Figure 4. In the left, the summation of SASA values is continuous as two atoms are approaching from a long distance and the minimal value occurs when two atoms are internally tangent. In the right, the magnitude of the atomic derivatives has a leap when two atoms are externally tangent at which the singularity occurs. As investigated in, 33 the singularity rarely happens when the solvent radius is 1.4 Å. In the implementation, we need one threshold value to determine the external tangency if ||. When , the external tangency was not detected after simulating a few systems for thousands of steps. When , there may occur one such case after dozens of simulation steps. On the other hand, the magnitude of the leap in the atomic derivatives is less than 20 Å2 and the surface tension is usually less than 0.01kcal/(mol⋅Å2), so the impact of such singularity is insignificant compared to the overall forces for exterior atoms whose magnitude can be more than 10 kcal/mol. Given the little chance of happening and the tiny impact of the singularity on the overall forces of the atoms, we can expect that the discontinuity in SASA calculation will have negligible impact on the trajectories in GB/SA simulations.
Implementation of dSASA on GPUs
As the implementation of MD in Amber has been done on GPUs, 17,29 our main concern here is to implement the method on GPUs to speed up the calculation, making it applicable to longer time MD simulations, so we discuss more details about the necessary treatments on GPUs below.
Weighted Delaunay Tetrahedrization
In the wDT, all possible connections among local points can be detected. Based on the coordinates and weights, four local points are assigned to a tetrahedron having the property that no other points will be inside the circumsphere of this tetrahedron. The wDT can be sequentially computed on CPUs with complexity . One parallel algorithm on GPUs to generate exact wDT for a large dataset remains a challenge. The typical GPU implementation of wDT often obtains a near-Delaunay tetrahedrization followed by transformation to CPU to generate the valid wDT. However, an algorithm gReg3D38 which is able to compute the exact wDT on GPUs was implemented a few years ago. In the algorithm, all points are first included into a cube with an appropriate size and next the points will be assigned to smaller cubes. The local tetrahedrization for these small cubes are calculated in parallel, followed by checking the consistency and applying necessary modifications to achieve the final wDT. The largest size of the initial cube in this algorithm is 512, so the point set with a greater size will be rescaled to fit into the cube, which may introduce a few errors. As the SARS-CoV-2 spike protein containing nearly 4000 residues typically occupies a cube with size 256, this algorithm can compute an exact wDT for proteins with thousands of residues on GPUs. As shown in Figure 1, the black points are the center of atoms and dashed lines connecting black points denote the edges in the tetrahedrization. The purpose of this step is to obtain the dual complex and the conjugated Laguerre diagram. In this diagram, every point is represented by a cell enclosed by the red solid lines and dashed curves, then the surface area can be calculated with such information.
Extraction of exterior simplices and calculation of surface areas
The information of close atoms in the tetrahedra has been achieved in the wDT above. However, some unrealistic connections and the interior contacts will not have contribution to surface areas. Then we need to extract the exterior simplices containing the feasible vertices, edges and triangles along with the connections among them, which will finally be used to calculate SASA. The extraction of simplices on CPUs is serial and cannot be implemented on GPUs directly. Here we provide more details for the extraction of simplices on GPUs.
We first need to create lists of unique triangles, edges and vertices with connection information. Take one tetrahedron as an example. It contains 4 triangles as faces, 6 edges and 4 vertices. One element in the list of triangles contains the information of three vertices and the tetrahedra it belongs to, one edge element contains the information of two vertices and the triangles and tetrahedra it is in, while one vertex element has the information of the associated edges and tetrahedra.
The exported information from gReg3D provides the vertex indices of all tetrahedra, so we can pull out all the information of edges and triangles in tetrahedra by taking advantage of the parallelism on GPUs. One list of all possible triangles is created and every element has three vertices and the associated tetrahedra. The list of all possible edges is constructed with each element containing two vertices and the associated tetrahedra. Suppose there are tetrahedra, then possible triangle elements and possible edge elements are in the lists respectively. However, some duplicate elements need to be filtered out to create the lists of unique elements. Take the list of triangles as an example shown in Figure 5. We first do lexical sorting for the list of triangles by the first three indices, bringing the same triangles next to each other. Next, with parallel computing, we can identify the number of the associated tetrahedra for a triangle. One triangle can belong to at most two tetrahedra. In the following assignment, every element will check the three vertices of the next element in the list, if three vertices are identical, then we will assign ‘1’ to the newly created array “idxTri” which indicates the triangle is duplicate, otherwise we assign ‘0’. We then can identify the unique triangle elements in the list and record the indices in one array “Tri”: a ‘1’ in “idxTri” is a new element, and the second ‘0’ in two consecutive ‘0’s indicates a new element as well. Now we have the indices for all unique triangles and the number of associated tetrahedra, then we can create the data structure “TriList” for these triangles. When creating triangles, we extract a list of edges and assign the associated triangle indices to this new list, which will provide partial information to edges. Following the similar process above, we can create the lists of unique edges and unique vertices respectively.
With the lists for vertices, edges and triangles, we next can classify them into interior and exterior, and record the indices of exterior simplices. The basic rule is: the triangle with at most one associated tetrahedron is exterior, and one edge is exterior only if its two vertices are both exterior. As shown in Figure 1, the atoms in green and blue are exterior while the grey atom is interior whose SASA value will be 0, the edge is exterior and the edges , are interior. For a molecule with 1700 atoms, the numbers of tetrahedra, triangles and edges are more than 11200, 22600 and 13000 respectively. These simplices can be independently implemented in parallel on a GPU to speed up the classification. Given the lists of exterior vertices, edges and triangles, we then can calculate atomic surface areas and gradients by Eqs. (1) and (2) in parallel and assign the values to individual atoms.
Simulated protein systems, RNA systems
Trp-cage variant Tc5b (PDB code, 1L2Y39) has 20 residues with the sequence NLYIQWLKD GGPSSGRPPPS, and the burial of the hydrophobic tryptophan side chain provides a driving force for its folding. It contains an -helix, a 310-helix and a C-terminal PPII helix and the Trp indole ring encapsulated in a cluster of Pro rings. The structure was determined via NMR experiment.
Homeodomain variant (PDB code, 2P6J40) contains 52 residues with sequence MKQW SENVEEKLKEFVKRHδQRITQEELHδQYAQRLGLNEEAIRQFFEEFEQRK. It is a variant of Drosophila melanogaster engrailed homeodomain and was solved by NMR. It consists of three α-helices connected by loop regions.
The 14-mer cUUCGg tetraloop hairpin RNA (PDB code, 2KOC41) is NMR-solved model and contains 14 bases with sequence GGCACUUCGGUGCC, with the common and highly stable UUCG loop.
The stem loop C 5’AUA3’ triloop of Brome Mosaic virus RNA (PDB code, 1ESH42) is composed of 13 bases with sequence GGUGCAUAGCACC. It is designed to contain the triloop AUA in the middle and is an NMR-solved model.
The CD experiments provide the melting curves for Trp-cage39 and the melting temperature for homeodomain variant.40 These two protein systems were studied in20 and the ab initio folding experiments in2 using the same force field and solvent model, providing a good reference to quantify the possible improvement by addition of a nonpolar solvation term. As mentioned above, it is important to compare results in which only the component of interest is varied.
Details of MD simulation
In the GB and GB/SA MD simulations, replica exchange molecular dynamics (REMD) was applied to enhance the efficiency of sampling. The setting for the system is as follows: all bonds involving hydrogen were added SHAKE constraints; Langevin dynamics (ntt = 3) with 1 collision frequency was used; the time step was 4 fs by following the protocol in43 through which the masses of hydrogen atoms can be repartitioned; exchanges between adjacent temperature replicas were attempted every 1 ps; conformations were extracted every 0.1 ns. Trp-cage and homeodomain were parametrized by ff14SBonlysc44 with GBNeck215 and mbondi3 radii.15 The surface tension parameter was extensively tested in pwSASA20 for proteins and 5, 7 and 10 cal/(mol·Å2) provided reasonable results when compared to simulations of a model system in explicit water. Thus we implemented the GB/SA simulations for LCPO, pwSASA and dSASA with 5 or 7 cal/(mol·Å2).
For Trp-cage, two production runs starting from unfolded and the first NMR structure were simulated for 1.0 μs in GB, LCPO, pwSASA and dSASA, with a REMD ladder of 8 temperatures (247.7, 264.0, 281.4, 300.0, 319.8, 340.9, 363.3, 387.3 K). The backbone RMSD cutoff 2.0 Å was applied to calculate the fraction of folded. For homeodomain variant, two production runs starting from extended and the first NMR structure were simulated with a ladder of 10 temperatures (288.7, 300.0, 311.7, 323.9, 336.6, 349.8, 363.5, 377.7, 392.4, 407.8 K) for 2.0 μs in GB and pwSASA, 1.0 μs for LCPO and dSASA. The backbone RMSD cutoff 5.0 Å was used to calculate the fraction of folded. These cutoffs are consistent with the study in.2,20 MD simulations were not performed for the RNA systems, since weaknesses in current RNA force fields make it challenging to obtain stable simulations for stable hairpins such as 2KOC even with fully explicit water.45 We therefore restrict our analysis to the SASA accuracy for RNA.
Results
Molecular SASA estimation
In the test set to validate SASA estimation, we selected eight proteins from the set of the previously examined proteins for ab initio protein folding, 2 in which the set of proteins have diverse topologies: Trp-cage (20 residues), Fip35 (33 residues), NTL9 (39 residues), BBL (47 residues), NuG2variant (56 residues), CSPA (69 residues), Lambda-repressor (80 residues) and Top7 (92 residues). An ensemble of structures for every protein were extracted from the protein folding trajectories in that work with an even interval, obtaining a set of conformations with diverse atomic and molecular SASA values. The corresponding data were estimated for every conformation using ICOSA, LCPO and pwSASA and dSASA. The numerical method ICOSA can provide more accurate SASA estimation for molecules than LCPO and pwSASA, so we mainly compared the molecular SASA values from dSASA with ICOSA. The results are shown in Figure 6 and every point represents one conformation in the trajectory. In all the systems, dSASA can generate well-correlated SASA values with ICOSA as Pearson correlation coefficients of the linear regression are R2 = 0.98,0.99 and the slopes are also close to 1. We note that this close agreement in fact demonstrates the relative accuracy of ICOSA as compared with our exact geometric method. However, ICOSA lacks the derivatives needed for MD simulation.
The molecular SASA values from LCPO and pwSASA were calculated using the same conformations and compared with ICOSA method. As shown in Figure 7, the discrepancy of LCPO molecular SASA values with ICOSA values varies for different conformations in the systems. Overall, the LCPO tends to underestimate the values with most of the values falling above the perfect agreement line. The correlation coefficients are around 0.9, but the slope and correlation are are lower than 0.9 for NTL9 and CSPA. The results became worse with pwSASA shown in Figure 8, where the similar phenomenon arose: the discrepancy of pwSASA molecular SASA values with ICOSA values varies for conformations in the systems; furthermore, all the correlation coefficients are less than 0.9 and the coefficients can be less than 0.8 for NTL9, BBL, NuG2variant and CSPA. This reflects on the goal of pwSASA being speed rather than accuracy.
Both LCPO and pwSASA use pairwise overlaps which can be relatively faster, but the inexact calculation will lead to inaccuracy especially for some types of atoms. For example, both methods occasionally produce unphysical negative SASA values for individual atoms, while the atomic values from dSASA are all nonnegative. LCPO includes the higher order correction terms to account for the overlap between two neighbors of the central atom. Then several atom types are defined by the environment, such as the atomic number, the number of bonded neighbors and the state of hybridization. Every atom type has predefined parameters through training. Because of less data for certain atom types, the parameter values for these atoms may generate unexpected values which explains the discrepancy for the proteins above. As noticed in, 28 the method works better for more exposed atoms and tends to overestimate the surface area of some buried atoms, such as the carboxyl carbons of the amino acids Asp, Asn, Gln and Glu. pwSASA only considers the overlap between neighboring pairs and compensated by training highly specific parameters applicable only to the atomic environments present in standard amino acids. Even though pwSASA introduced many additional empirical parameters, it suffers similar problems as LCPO, likely due to weak transferability of the pair parameters, and accounting for 3-body and higher terms only in an average way. In fact, the pwSASA values are not the original SASA values because it introduces an empirical adjustment to the SASA values to compensate for a systematic divergence from the numerical ICOSA calculations, which may adversely affect the overall accuracy as well.
Speed Comparison in GB/SA MD
The original version of dSASA was implemented on CPUs, and the transformation to a GPU version speeds up the computation by taking advantage of the parallel computing. The program written in CUDA was integrated to the Amber20 version. In sander, pmemd, or pmemd.cuda, setting the gbsa flag to 4 in GB suite will activate GB/SA simulations with dSASA. We first compared the speed of GB/SA MD on GPU with CPU and next with other methods using 10 proteins with various sizes ranging from 10 residues to 190 residues. 4 of them were selected from above and the PDB code of the rest are given: 10 (PDB code, 5AWL), 20, 33, 52 (2P6J), 69, 92, 110 (1BYW), 130 (1E6K), 162 (2B75) and 190 (1BK7).
We benchmarked the method on the CPU Intel Platinum 8268 2.90GHz and on the GPU Nvidia RTX 2080 Ti. The estimated wallclock time for one step SASA calculation on CPU is from 12 ms (10 residues) to 90 ms (190 residues), while the time trend on GPU is from 12 ms to 30 ms. The wallclock time here and below is averaged over several simulations. The speed on CPU is comparable to the speed on GPU when the size of protein is small, and the speed on GPU becomes relatively faster as the size of the protein increases. The estimated wallclock time in hours required to complete 1 ns GB/SA simulation in Amber is given in the left of Figure 9. The wallclock time required to finish 1 ns simulation on the CPU increases from 0.87 hour (10 residues) to 33.80 hours (190 residues), while the corresponding trend of timing on the GPU is from 0.6 hour to to 1.87 hours. When the size of protein is small, the improvement of GPU over CPU version is small with speedup 1.44 times for 10 residues, while the speedup grows as the size of molecule is increasing to 18.07 times for 190 residues. For the system with 190 residues, we tested the parallel version with multiple CPUs. The GPU version is still much faster than the parallelized CPU version. The speedup of the GPU version over parallel version with 4, 8, 16 CPUs is 7.6, 9.1, 4.8, respectively.
We next compared the speed with other methods in Amber using the same set of systems above. The wallclock time in hours needed to complete 1 ns simulation is provided in the right of Fig. 9. The speed of pwSASA is stable and much faster than other two methods as it is designed to have a fast and simple estimation with more approximations, so we can confirm that the accuracy of the method is at cost of speed as LCPO and dSASA can reproduce more accurate SASA values by the testing above. As can be seen in Fig. 9, the speed of dSASA is more stable as the size of the system grows, while LCPO has a steeper increasing trend when the size of the molecule becomes larger. When the size of the system is small (10 residues), dSASA is slower than LCPO. While the crossing point is around the size of 69 residues and after that, dSASA starts to gain advantage over LCPO for 69, 92 residues and the speedup becomes greater for larger systems. This phenomenon fits the computation complexity for these two methods: the computation complexity of LCPO is while the complexity of dSASA is (the complexity of tetrahedrization algorithm), so the system with a larger size will have relatively better performance. Another reason is that the GB/SA simulation with LCPO is CPU/GPU hybrid so the data transfer further hinders the performance. On the other hand, pwSASA is ~80 times faster than dSASA for small proteins, reducing to ~50 times for larger proteins. While pwSASA is a pairwise method and its computation complexity is also however its computation is efficiently embedded in the overall energy computation which is of the same order; thus pwSASA adds little to the overall computational cost.
Stability Analysis of Proteins
dSASA can estimate the molecular SASA accurately in proteins with diverse shapes based on the testing above. With the speedup on GPUs, it is now possible to examine its performance in GB/SA simulations and evaluate its effect on the stability of protein structures. However, comparison of the simulation results to experiments should be done with the understanding that deviations can arise from inaccuracy in any of the multiple components of the model (such as the biopolymer force field or GB model, which typically contribute more than the SASA term). Additionally the implicit solvation models may become less reliable away from 300 K. Given these caveats, we simulated two proteins with dSASA and compared the results with experiments, GB-only and other SASA methods. The trends in the simulations can provide useful information albeit with these limitations. The thermal stability profiles of Trp-cage and the fraction of folded on homeodomain are calculated from REMD at various temperatures. The temperature ladder for Trp-cage contains 8 replicas (247.7–387.3 K, see Methods for full list). The ladder for homeodomain has 10 replicas (288.7–407.8 K).
The default surface tension value in Amber GB/SA module is 5 cal/(mol·Å2)4 and the recommended value is 7 cal/(mol Å2)5 for pwSASA.20 For Trp-cage, we tested surface tension values of 5 and 7 to examine the performance of the method. For homeodomain, we only used the value 7, which can produce more near-native states in the trajectories.
The thermal stability profiles of Trp-cage with surface tension 5 and 7 cal/(mol·Å2) were first computed and the fractions of the near native conformations are given in Figure 10 for all methods. The left shows the results with the surface tension 5 cal/(mol·Å2), while the right shows the results with the surface tension 7 cal/(mol·Å2). With surface tension of 5, all three methods incorporating the nonpolar term achieve better agreement with experiments by creating more stable thermal stability profiles at various temperatures. At 300 K, simulations using dSASA generate ~75% fraction of folded states while other methods with nonpolar term and experimental results are ~80% and the GB-only leads to ~50%. When the temperature is greater than 310 K, the fraction of folded from dSASA is still slightly smaller than other methods but dSASA can produce closer results to the experiments. The predicted melting temperature is 316.8 K and the experimental result is around 317 K, which is better than the GB-only (predicted is around 300 K) and other methods (predicted is greater than 320 K for LCPO and pwSASA). Moreover, it is expected that a larger surface tension can generate more native-like conformations through which we can demonstrate that the nonpolar term does not disrupt the system. As shown in the right of Figure 10, all three methods can generate more native-like structures with surface tension 7 cal/(mol·Å2). To show the extent of dynamics and variation in sampled RMSD, we provide the detailed trajectories at several temperatures for Trp-cage starting from extended and native states with surface tension 5 cal/(mol·Å2) in Supporting Information.
For the homeodomain variant, we first carried out REMD with surface tension 5 cal/(mol·Å2) using pwSASA for 2 μs, but we noticed that the fraction of folded was far from the experimental results at higher temperatures. The experimental measured is greater than 372 K, so we expect a larger surface tension can achieve better agreement with experiments. We then simulated with surface tension 7 cal/(mol·Å2) for all GB/SA methods. All three methods with nonpolar term can improve the fraction of folded at various temperatures compared to GB-only. The fractions of native-like starting from native and unfolded states at selected temperatures are shown in Figure 11. Since the experimental is greater than 372 K, we expect that the system will not collapse at high temperatures. The two more accurate SASA methods, LCPO and dSASA, produce more native-like conformations at higher temperatures as shown in Figure 11. Moreover, dSASA generated more native-like conformations than LCPO at various temperatures, demonstrating that our method can have a better effect on stabilizing the system. The detailed trajectories of homeodomain at selected temperatures starting from extended and native states with surface tension 7 cal/(mol·Å2) are given in Supporting Information. Furthermore, at the temperature 300 K, the difference between the native-like fractions of the simulations starting from native and extended is around 20% for dSASA and LCPO after 500 ns simulations, while that difference is around 40% for GB and pwSASA even after 1000 ns simulations, indicating that the inclusion of an accurate SASA term might lead to improved sampling and faster convergence (or conversely, that the SASA approximations may lead to increased kinetic traps). The improved performance from dSASA still has variance from the experimental results, for example the fraction of native-like at 377.7 K is around 35% while it is 50% in experiment. Such discrepancy may come from limitations of the SASA-based nonpolar term, or from the force field and the polar GB term; comparison of simulation results to experiment typically does not reveal which component is responsible, and further model system development is needed.
Performance on RNA systems
Another advantage of dSASA over pwSASA is that it can be applied to other types of systems such as nucleic acids or small-molecule ligands, because only the radii of the atoms are considered without defining diverse atom types. Here we test this aspect using two RNA systems, 2KOC and 1ESH, and compare the molecular SASA values with ICOSA and other methods to see if the excellent performance on proteins is transferable to other biopolymers. Simulation results for RNA are not presented in details, since accurate force fields and implicit solvent models for RNA are still a matter of active research.45,46
To validate the SASA estimation, we generated alternate conformations for these RNA systems with the GB-only method for 1 μs and extracted 104 conformations for each system respectively. The comparison of the molecular SASA values between all methods is shown in Figure 12. dSASA can reproduce SASA values from ICOSA with more than 98% accuracy for both systems while LCPO and pwSASA produced divergent results for two systems and they had overall underestimation of the SASA values. The SASA estimates from pwSASA have large discrepancy from ICOSA method, likely because it was trained exclusively on protein data so that the parameters do not accurately model the specific atom types and local environments present in RNA. Overall, the results confirm the expected outcome that dSASA accuracy is transferable across diverse molecular systems.
Conclusions
In this work, we present dSASA, an analytical SASA evaluation method for molecules and its implementation on GPUs. In this approach, the weighted Delaunay tetrahedrization is first computed with the atomic coordinates and radii. Next the atomic and molecular SASA values are estimated using inclusion-exclusion method based on exterior simplices from tetrahedrization, resulting in more accurate estimation than LCPO and pwSASA in reproducing numerical ICOSA SASA values. The pre-trained parameters for atoms in LCPO and pwSASA can speed up the calculation, but these parameters can have low transferability. This is confirmed by comparison of computed molecular SASA values, which for these approximate methods had smaller correlation coefficients with the values from ICOSA method, such as in the protein systems CSPA and NuG2variant and RNAs. In contrast, estimation from dSASA can reproduce ICOSA values with correlation coefficients greater than 98%. Moreover, the current GPU version speeds up the calculation substantially compared with the CPU version, making it applicable for longer time GB/SA MD simulations especially for larger systems. The gain of speed arises from the complexity of the algorithm itself which will scales well for larger systems and from the full implementation on GPU devices removing the data transfer with CPUs. dSASA has a stable trend of speed as the size of molecule increases but it is still relatively slower than the highly approximate pwSASA. However, dSASA started to outperform LCPO when the system contains around 70 residues, and the performance for larger molecules would be more stable than LCPO because the computation in LCPO is pairwise and its implementation is CPU/GPU hybrid in Amber.
In the GB/SA simulations, two proteins (Trp-cage and homeodomain) were simulated and compared to other methods and experimental results. dSASA achieved comparable performance with LCPO and pwSASA on the small protein, and the performance became better for the larger system. The simulated melting curve with nonpolar term for Trp-cage was more consistent with the experimental measures compared with that without nonpolar term. In homeodomain variant, the melting temperature is greater than 372 K so we expect the system can maintain some amount of native-like conformations at higher temperatures. The simulations generated more extended conformations with other methods at high temperatures while dSASA can produce more native-like conformations in the trajectories which is closer to the experimental data. However, these comparisons to experiment must be considered in the context of the other force field components as well.
As the program has been rigorously examined, we anticipate to extend its applications to other functions in Amber software, such as post-processing of the trajectories in MM-PBSA or MM-GBSA. The calculation in dSASA is geometry based, obtaining accurate results with the provided atomic coordinates and radii. Therefore it can be used for diverse types of systems without restrictions, such as the simulations of larger proteins, protein-ligand complexes, and protein-nucleic acids complexes. 1 nanosecond GB/SA simulation for 200-residue proteins with dSASA takes around two hours. Even though it is slower than pwSASA, the accuracy of the method will allow us to explore the impact of the nonpolar term on the simulations in the future. Given the accuracy of dSASA, the calculation of atomic and molecular SASA values can be benchmark data set for the training of the parameters in pwSASA approach for RNAs in the future, which will combine the advantage of its speed on GPUs and the accurate calculation from dSASA. The SASA is certainly an approximation to nonpolar solvation, but many studies have shown that including it improves agreement with experiment for things like protein stability or binding affinities.12 In addition, dSASA, a more accurate SASA with derivatives implemented on GPUs, will also enable fast polar solvation methods for MD. Furthermore, the calculation of SASA is based on the diagram of Laguerre intersection cells, so it can be easily extended to the computation of molecular volumes along with the corresponding atomic derivatives. Inclusion of the volume term will provide a more complete description for the nonpolar solvation term. With the volume derivatives, we can further examine the impact of the term on the stability of molecules in the MD simulations. Moreover, the current algorithm being used for weighted Delaunay Tetrahedrization, gReg3D, is designed to work on a set of random points and the size of the workspace depends on the distribution of points in the workspace. As it consumes nearly 70% of wallclock time of our surface area calculation, improvement on this algorithm will further speed up the simulations. The program of dSASA written in CUDA will be freely available from the authors.
Acknowledgement
This work was partly supported by NIH Grants RM1 GM135136 and R01 GM107104, and by NSF Grant DMS 2054251. We gratefully acknowledge support from Laufer Center for Physical and Quantitative Biology.
Footnotes
Associated Content
Supporting Information available.
Examination of energy conservation after including dSASA term in MD. Detailed trajectories with dSASA, GB, LCPO and pwSASA for Trp-cage and Homeodomain at selected temperatures. Fractions of folded for the second test set of Homeodomain.
References
- (1).Fennell C. J.; Dill K. A. J. Stat. Phys. 2011, 145, 209–226. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (2).Nguyen H.; Maier J.; Huang H.; Perrone V.; Simmerling C. J. Am. Chem. Soc. 2014, 136, 13959–13962. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (3).Perez A.; Morrone J. A.; Brini E.; MacCallum J. L.; Dill K. A. Sci. Adv. 2016, 2, 1601274. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (4).Stikoff D.; Sharp K. A.; Honig B. J. Phys. Chem. 1994, 98, 1978–1988. [Google Scholar]
- (5).Still W. C.; Tempczyk A.; Hawley R. C.; Hendrickson T. J. Am. Chem. Soc. 1990, 112, 6127–6129. [Google Scholar]
- (6).Kollman P. A.; Massova I.; Reyes C.; Kuhn B.; Huo S.; Chong L.; Lee M.; Lee T.; Duan Y.; Wang W.; Donini O.; Cieplak P.; Srinivasan J.; Case D. A.; Cheatham T. E. Acc. Chem. Res. 2000, 33, 889–897. [DOI] [PubMed] [Google Scholar]
- (7).Levy R. M.; Zhang L.; Gallicchio E.; Felts A. K. J. Am. Chem. Soc. 2003, 125, 9523–9530. [DOI] [PubMed] [Google Scholar]
- (8).Honig B.; Nicholls A. Science 1995, 268, 1144–1149. [DOI] [PubMed] [Google Scholar]
- (9).Eisenberg D.; McLachlan A. D. Nature 1986, 319, 199–203. [DOI] [PubMed] [Google Scholar]
- (10).Wagoner J. A.; Baker N. A. Proc. Natl. Acad. Sci. USA 2006, 103, 8331–8336. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (11).Allison J. R.; Boguslawsk K.; Fraternali F.; van Gunsteren W. F. J. Phys. Chem. B 2011, 115, 4547–4557. [DOI] [PubMed] [Google Scholar]
- (12).Genheden S.; Ryde U. Expert Opin. Drug Discov. 2015, 10, 449–461. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (13).Onufriev A.; Bashford D.; Case D. A. Proteins: Struct., Funct., Bioinf. 2004, 55, 383–394. [DOI] [PubMed] [Google Scholar]
- (14).Mongan J.; Simmerling C.; McCammon J. A.; Case D. A.; Onufriev A. J. Chem. Theory Comput. 2007, 3, 156–169. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (15).Nguyen H.; Roe D. R.; Simmerling C. J. Chem. Theory Comput. 2013, 9, 2020–2034. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (16).Nguyen H.; Perez A.; Bermeo S.; Simmerling C. J. Chem. Theory Comput. 2015, 11, 3714–3728. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (17).Case D. A.; Cerutti D. S.; Cheatham III T. E.; Darden T. A.; Duke R. E.; Giese T. J.; Gohlke H.; Goetz A. W.; Greene D.; Homeyer N. e. a. University of California: San Francisco: 2017, [Google Scholar]
- (18).Hawkins G. D.; Cramer C. J.; Truhlar D. G. Chem. Phys. Lett. 1995, 246, 122–129. [Google Scholar]
- (19).Lang E. J.; Baker E. G.; Woolfson D. N.; Mulholland A. J. J. Chem. Theory Comput. 2022, 18, 4070–4076. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (20).Huang H.; Simmerling C. J. Chem. Theory Comput. 2018, 14, 5797–5814. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (21).Lee B.; Richards F. M. J. Mol. Biol. 1971, 55, 379–400. [DOI] [PubMed] [Google Scholar]
- (22).Connolly M. L. J. Appl. Crystallogr. 1983, 16, 548–558. [Google Scholar]
- (23).Durham E.; Dorr B.; Woetzel N.; Staritzbichler R.; Meiler J. J. Mol. Model. 2009, 15, 1093–1108. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (24).Juba D.; Varshney A. J. Mol. Graphics Modell. 2008, 27, 82–87. [DOI] [PubMed] [Google Scholar]
- (25).Dynerman D.; Butzlaff E.; Mitchell J. C. J. Comput. Biol. 2009, 16, 523–537. [DOI] [PubMed] [Google Scholar]
- (26).Lee K. H.; Chen J. J. Comput. Chem. 2017, 38, 1332–1341. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (27).Gong X.; Chiricotto M.; Liu X.; Nordquist E.; Feig M.; Brooks III C. L.; Chen J. J. Comput. Chem. 2020, 41, 830–838. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (28).Weiser J.; Shenkin P. S.; Still W. C. J. Comput. Chem. 1999, 20, 217–230. [DOI] [PubMed] [Google Scholar]
- (29).Gotz A. W.; Williamson M. J.; Xu D.; Poole D.; LeGrand S.; Walker R. C. J. Chem. Theory Comput. 2012, 8, 1542–1555. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (30).Edelsbrunner H. Discrete Comput. Geom. 1995, 13, 415–440. [Google Scholar]
- (31).Cazals F.; Kanhere H.; Loriot S. ACM Trans. Math. Softw. 2011, 38, 1–20. [Google Scholar]
- (32).Bryant R.; Edelsbrunner H.; Koehl P.; Levitt M. Discrete Comput. Geom. 2004, 32, 293–308. [Google Scholar]
- (33).Hummel M. H. Delaunay-Laguerre geometry for macromolecular modeling and implicit solvation. Ph.D. thesis, The University of New Mexico, 2014. [Google Scholar]
- (34).Hummel M. H.; Yu B.; Simmerling C.; Coutsias E. A. Int. J. Comput. Geom. Appl. 2018, 28, 1–38. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (35).Koehl P.; Akopyan A.; Edelsbrunner H. J. Chem. Inf. Model. 2023, 63, 973–985. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (36).Shrake A.; Rupley J. A. J. Mol. Biol. 1973, 79, 351–371. [DOI] [PubMed] [Google Scholar]
- (37).Vasilyev V.; Purisima E. O. J. Comput. Chem. 2002, 23, 737–745. [DOI] [PubMed] [Google Scholar]
- (38).Nanjappa A. Delaunay Triangulation in R3 on the GPU. Ph.D. thesis, Singapore National University, 2012. [Google Scholar]
- (39).Neidigh J. W.; Fesinmeyer R. M.; Andersen N. H. Nat. Struct. Biol. 2002, 9, 425–430. [DOI] [PubMed] [Google Scholar]
- (40).Shah P. S.; Hom G. K.; Lassila J. K.; Crowhurst K. A.; Mayo S. L. J. Mol. Biol. 2007, 371, 1–6. [DOI] [PubMed] [Google Scholar]
- (41).Nozinovic S.; Fürtig B.; Jonker H. R. A.; Richter C.; Schwalbe H. Nucleic Acids Res. 2010, 38, 683–694. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (42).Kim C. H.; Kao C. C.; Tinoco I. Jr. Nat. Struct. Biol. 2000, 7, 415–423. [DOI] [PubMed] [Google Scholar]
- (43).Hopkins C. W.; LeGrand S.; Walker R. C.; Roitberg A. E. J. Chem. Theory Comput. 2015, 11, 1864–1874. [DOI] [PubMed] [Google Scholar]
- (44).Maier J. A.; Martinez C.; Kasavajhala K.; Wickstrom L.; Hauser K. E.; Simmerling C. J. Chem. Theory Comput. 2015, 11, 3696–3713. [DOI] [PMC free article] [PubMed] [Google Scholar]
- (45).Mráziková K.; Mlýnský V.; Kührová P.; Pokorná P.; Kruse H.; Krepl M.; Otyepka M.; Banáš P.; Šponer J. J. Chem. Theory Comput. 2020, 16, 7601–7617. [DOI] [PubMed] [Google Scholar]
- (46).Liebl K.; Zacharias M. Biophys. J. 2023, 122, 2841–2851. [DOI] [PMC free article] [PubMed] [Google Scholar]