Skip to main content
NIHPA Author Manuscripts logoLink to NIHPA Author Manuscripts
. Author manuscript; available in PMC: 2017 Aug 25.
Published in final edited form as: J Phys Chem B. 2016 May 3;120(33):8354–8360. doi: 10.1021/acs.jpcb.6b02059

Energy Minimization of Discrete Protein Titration State Models Using Graph Theory

Emilie Purvine †,*, Kyle Monson †,*, Elizabeth Jurrus †,*, Keith Star †,*, Nathan A Baker ‡,¶,*
PMCID: PMC5001885  NIHMSID: NIHMS783914  PMID: 27089174

Abstract

There are several applications in computational biophysics which require the optimization of discrete interacting states; e.g., amino acid titration states, ligand oxidation states, or discrete rotamer angles. Such optimization can be very time-consuming as it scales exponentially in the number of sites to be optimized. In this paper, we describe a new polynomial-time algorithm for optimization of discrete states in macromolecular systems. This algorithm was adapted from image processing and uses techniques from discrete mathematics and graph theory to restate the optimization problem in terms of “maximum flow-minimum cut” graph analysis. The interaction energy graph, a graph in which vertices (amino acids) and edges (interactions) are weighted with their respective energies, is transformed into a flow network in which the value of the minimum cut in the network equals the minimum free energy of the protein, and the cut itself encodes the state that achieves the minimum free energy. Because of its deterministic nature and polynomial-time performance, this algorithm has the potential to allow for the ionization state of larger proteins to be discovered.

Introduction

There are many problems in computational physics and biophysics which require optimization over an exponentially large state space. In this paper we demonstrate an algorithm adapted from computer vision for optimization over an exponentially large space in polynomial time for pairwise-decomposable interactions between states. We focus on the problem of macromolecular titration state assignment; however, there are many other exponential space optimization problems in computational biophysics, including inverse folding, 1,2 protein design, 36 and protein structure optimization. 7,8

Because hydrogens are rarely present in x-ray crystallographic structures, protein titration states often need to be computationally assigned to each titratable amino acid, including N- and C-termini, in the molecule. 9 The bases for most modern protein pKa were established by Bashford and co-workers who developed both brute force and Monte Carlo procedures for generating titration curves10,11. The pKa value of an amino acid or residue, together with the solution pH, provides a measure of the probability of protonation for a titration state: pKa = – log10 Ka, where Ka is the acid dissociation equilibrium constant for the residue. Experimental methods provide the best mechanisms for determining both pKa values and titration states of a protein residue, 1214 but experimental work is both time- and resource-consuming, so computational methods offer a compelling alternative for estimating pKa values and assigning titration states using a variety of physics- and statistics-based methods.15 However, these calculations can be computationally demanding as they require the calculation of all 𝓞 (N 2) pairwise interactions between all N titratable residues, to determine intrinsic site pKa values,16 followed by optimization over the 𝓞 (2N) potential titration states of the system.

There are several approaches to such optimization, including sampling approaches such as Monte Carlo simulation 10,11,1722, molecular dynamics, 2326 and deterministic optimization methods such as dead-end elimination (DEE).27,28 Sampling methods explore the optimization landscape using random move sets or trajectories generated from force-field-based equations of motion. These methods have the advantage of generating thermodynamic ensembles through their sampling and are able to sample systems with complex energy functions; however, these methods are not guaranteed to find global minima. In contrast, the DEE approach – and its variants such as DEEPer28 – are global optimization approaches. However, these approaches are restricted to pairwise-decomposable energy functions to accelerate the search, thus limiting the complexity of energy functions for the system.

The approach we describe in this paper is most closely related to DEE and its variants. Like DEE, we are guaranteed to find a minimum energy state through a deterministic, polynomial time process. The DEE algorithm scales cubically with the total number of rotamers in the system. The algorithm we describe in this paper relies on the use of the max-flow/min-cut theorem. There are new algorithms that approximate the minimum cut in roughly linear time in the number of edges,29 which results in an algorithm which is quadratic in the number of titratable residues. As in DEE, we are currently limited by pairwise-decomposable energy functions, however with more research we hope to be able to extend this work to energy functions with higher order interactions (ternary, etc.), possibly through the use of hypergraphs.

Methods

Energy functions for titration state assignment

In this initial work, we will be following the simple and common approach16 of assigning titration states to a rigid protein, wherein the backbone and amino acid locations are fixed. It is important to note that, for the current paper, we are assigning specific titration states and not assigning pKa values or titration probabilities. Titration state assignment is important for setting up a variety of constant-titration calculations such as standard molecular dynamics simulations, docking simulations, etc. The full calculation of titration curves is a longer-term application of this method. All titratable amino acids, with the exception of histidine (HIS), are assumed to have two possible states: protonated or deprotonated. This assumption ignores (or assumes equivalent) the various tautomers and conformers that can be present for many amino acids; these cases will be addressed in future work. Histidine has three possible titration states which should not be considered equivalent:30 a singly protonated state with a hydrogen on NE, a singly protonated state with a hydrogen on Nδ, and a doubly protonated state with hydrogens on both nitrogens. The state in which both Nδ and NE are deprotonated is highly energetically unfavorable and thus will be ignored.

For N titratable residues, the set of all protonation states, 𝓟, of any protein without HIS can be described as the set of all {0, 1} vectors of length N ; i.e., 𝓟 = {0, 1}N. If there are M HIS residues then 𝓟 = {0, 1}N–M × {0, 1, 2}. Our goal in titration state assignment is to find a titration state P in 𝓟 which minimizes the protein’s energy at a given pH (or proton activity), volume, and temperature T. This free energy is often approximated as a pairwise-decomposable function between titration sites:31,32

G(P)=i=1Nγiln(10)kT(pHpKainti)+i=1Nj=1NγiγjUint(Pi,Pj) (1)

where γi is 1 when amino acid i is charged and 0 otherwise, pKainti is the intrinsic pKa of amino acid i, and U int(Pi, Pj) is the interaction energy between amino acids i and j. The intrinsic pKa value of amino acid i is the pKa value if all other amino acids are in their neutral state. Our formulation of the free energy is slightly different, though equivalent.

Traditionally, the pKa of a given residue can be determined from the titration curve for that residue. The titration curve is a plot of fractional proton occupancy vs. pH, and the pH value at which the fractional proton occupancy is 1/2 will give the pKa value. When there is a greater than 0.5 probability that the residue is protonated (resp. deprotonated), then we consider it protonated (resp. deprotonated). However, these fractional proton occupancies 32 are computationally intensive to compute since they require computation of energy of the protein in all 2N states:

fi=j=12NγiexpG(Pj)kTj=12NexpG(Pj)kT, (2)

where fi is the fractional proton occupancy of residue i, j runs through all of the 2N protonation states, γi is 1 if residue i is charged in state j and zero otherwise, P j is the jth protonation state, and G(P j) is the energy described in Eq. 1 for protonation state P j.

Instead of computing fractional occupancy via the ensemble average above, we follow basic two-state linkage analysis to approximate the protonated fraction. 33,34 We define Gp(i) to be the change in energy between the states where residue i is protonated and where it is deprotonated. Given this definition, the fraction of protonated state is given as

θp(i)=eβGp(i)1+aHeβGp(i), (3)

where β = (RT)1, R is the gas constant, T is the temperature, and aH is the activity of the proton. The form for HIS residues is similar but differs slightly due to the three-state system. Below we drop the i from the formulas when the residue is clear, for easier readability. If we assume the anionic state of HIS is energetically prohibited, then there are three potential states for the system

θδ=11+eβΔG+aHeβGp, (4)
θ=eβΔG1+eβΔG+aHeβGp, (5)
θp=aHeβGp1+eβΔG+aHeβGp, (6)

where ΔG is the difference in energy between the δ and E states of HIS, θδ is the fraction of states with HIS having a single proton on the δ nitrogen, θE is the fraction of states with HIS having a single proton on the E nitrogen, and θp is the fraction of states with doubly protonated HIS. Our method relies on finding a minimum energy state for the protein at any given pH value, changing the state of each residue, and recording the change in energy. The method in this paper is focused on finding that minimum energy state efficiently. We then use that information to calculate the titration curve using Eq. 3 and Eq. 6, and subsequently the pKa value for each residue from the titration curves.

In order to calculate the individual energies contained in Eq. 1, we employ PDB2PKA, a part of the PDB2PQR35,36 package based on the pKa methods of Nielsen et al.37 The interaction energy U (Pi, Pi) in Eq. 1 includes background and desolvation energies, while U (Pi, Pj) for ij includes Coulombic and steric interaction energies 35,37 between sites. The background energy of site i is simply the energy of the site if all other contributions (other amino acids and the solvent) are removed. The desolvation energy, on the other hand, quantifies the interaction between the amino acid and the solvent, assuming all other amino acids are in their neutral state. The electrostatic contributions to these energies are calculated via the Poisson-Boltzmann equation through the software package APBS;38 the steric interaction energies are calculated via PDB2PQR. 35,36 When two amino acid states have steric clashes, a “bump” term is added in the form of a large unfavorable energy contribution to reduce the probability of the two states happening simultaneously. In the current work, the PARSE39,40 forcefield is used for protein radii and charge parameters.

In addition to calculating interaction, background, and desolvation energies, PDB2PKA contains a Metropolis Monte Carlo for calculating titration curves and pKa values. The PDB2PKA Monte Carlo algorithm starts with a random titration state for each residue in the protein. For each step, the algorithm selects a random titration state for a random residue and calculates the energy difference ΔGi–1,i with respect to the previous step. If the energy is lower, the random titration move is accepted, otherwise it is accepted with a probability equal to eβΔGi–1,i. The last 90% of the steps in the Monte Carlo simulation are used to estimate fractional proton occupancy by calculating the fraction of Monte Carlo steps in which the residue was protonated.

In what follows, we compare this Monte Carlo approach with our energy minimization approach for the purpose of demonstrating our new optimization algorithms and qualitatively assessing their accuracy. However, we recognize that these two algorithms use different approaches for pKa calculations. The PDB2PKA Monte Carlo approach samples multiple states by implicitly calculating the probabilities presented in Eq. 2. Our approach uses Eq. 3 to directly calculate the pKa value, effectively neglecting the entropic contributions of multiple energetically accessible titration states. In future work, we plan to improve our algorithm to use the calculated minimum energy state as the reference structure for Monte Carlosampling.

Discrete optimization and graph theory

Research efforts in the field of computer vision (e.g., image restoration, image synthesis, image segmentation, multi-camera scene reconstruction, and medical imaging) focused on efficient algorithms for energy minimization via graph cuts in networks.4143 Such applications often focused on the restoration of an image (a collection of pixels and possible pixel labels); e.g., the image may contain noise to be removed, sections to be segmented, or disconnected images that need to be integrated into a single image. These algorithms are designed to minimize an energy function which assigns an energy to each pixel based on its label (e.g., hue, intensity, segment membership, etc.) and to each pair of interacting pixels (usually neighbors) based on an interaction function. Thus, the energy function takes the form

E(L)=i=1NEi(Li)+(i,j)εEij(Li,Lj) (7)

where L=L1,L2,,LN, Li is the label of pixel i, and E is the list of pixel interactions, such that pixels i and j are said to interact if (i, j) ∈ E. Notice that our protein energy function Eq. 1 can be written in this form with

Ei=γiln(10)kT(pHpKainti)+γi2Uint(Pi,Pi),
Eij=γiγjUint(Pi,Pj),
ε={(i,j):ij}.

As a result of this similar pairwise-interaction form, we can apply the discrete minimization techniques established for computer vision to our protein problem. In the case of two-state labels, where amino acids can be only protonated or deprotonated, we can use these computer vision optimization methods directly. We are also able to adapt these methods to the case of HIS which has three titration states, as described below.

Application of graph theory to energy minimization

To begin, we restrict our attention to proteins without HIS so that each amino acid has only two choices for its “label”: protonated or deprotonated. Below, we will discuss a method to include HIS in the graph-cut algorithm described above. The first step is to create a weighted graph which holds all of the information from the energy function. We will call this the energy graph. Each amino acid will be represented by two vertices, one for each titration state. If there are N amino acids in the protein then there are 2N vertices in the graph. Each amino acid,configuration pair, i,Pi, has energy contributions from the difference between its intrinsic pKa and the current pH value, as well as the γi2Uint(Pi,Pi) background and desolvation energies, which we combine into Ei(Pi) as in Eq. 7. This energy will be assigned as a weight on each vertex. Additionally, each pair of amino acids can interact in both of their titration states, but amino acid i in its deprotonated state cannot interact with itself in its protonated state. Therefore, for each pair of amino acids there are 4 edges, with a total of 4(N2)=2N(N1) edges for the entire protein. Edge weights are given by the interaction energy for the particular amino acids and configurations, γiγj U int(Pi, Pj) as in Eq. 1. Additional information including graph theory background, details for constructing the energy graph, and example graphs are given in Supporting Information.

The energy graph can be simplified by moving some edge weights to the vertices, and some vertex weights into a universal constant. Through this simplifying process, we will end up with the normal form of the energy graph44 where all of the edge and vertex weights are non-negative and as many as possible have weight zero. The normal form energy graph is then transformed into an energy flow network using a procedure which guarantees that the minimum cut in the network will equal the minimum energy of the protein titration system. The graph transformation via simplification to normal form and representation as an energy flow network is described in Supporting Information. Note that, after these transformation processes, the edge weights still represent energy values but are no longer interaction energies between the protonation states represented by the vertices in the edge. Instead, these energies represent interactions between groups in the new sparser graph created by the normalization process.

The energy of a protonation state can be determined by choosing the vertices in the energy flow network corresponding to that particular protonation state, discarding all other vertices (and corresponding edges), and taking the sum of the edge and vertex weights that remain. Therefore, a naïve approach to energy minimization would use this procedure to find the energy for all 2N possible protonation states and choose the state which has the minimum energy. However, this brute-force algorithm has exponential complexity, making it infeasible for even moderate-size proteins. This selection of vertices and edges in the energy graph can also be represented through a graph cut in the energy flow network as detailed in Supporting Information. Briefly, a graph cut defines a given protonation state of the protein by assigning all vertices associated with that protonation state into one set, and all others into a second set. It can be shown that the cut value associated with this cut, the sum of edge weights for all edges from vertices in the first set to vertices in the second, plus the global constant from the normal form procedure, is exactly the energy of the associated state of the system.44 Additional requirements are needed to ensure that the minimum cut in the network yields the minimum energy configuration. In a 2004 paper, Kolmogorov and Zabih 42 proved for pairwise-interacting states where all pairwise interactions are submodular, it is possible to find the exact minimum energy state in polynomial time by computing the minimum cut on the flow network of the associated graph. For our titration state application, submodularity means that, for all pairs of amino acids, the interaction energy when they are in the same state is smaller than the interaction energy if they are in different states. In other words, submodularity implies that the sum of interaction energies for the singly-protonated states exceeds the sum of those for the the doubly-deprotonated and doubly-protonated states.

Protein titration site interaction networks are not guaranteed to have submodular energies. However, it is still possible to use the graph-cut method to label the portion of the amino acids whose energy functions are submodular. 44 The remaining amino acids must be assigned by some other optimization method (e.g., Monte Carlo or brute force) on only the unassigned amino acids. In the Discussion, we discuss the practical implications of unassigned amino acids. We note that the number of unassigned residues is highly dependent on algorithms used to construct and cut the interaction energy graph. Because of this issue, we are not able to predict the number of unassigned residues by just looking at the interaction energies. In future work, we plan to exploit the use of multiple different minimum cut algorithms to obtain the smallest number of unassigned amino acids, since all are fast to run but some yield fewer unassigned amino acids than others.

Moving beyond two states per amino acid

The discussion of the previous section was limited to minimizing two-state titratable systems using graph cuts. However, as mentioned in the introduction, not all titration sites can be represented simply by two states. In particular, HIS must be represented with three titration states: two neutral tautomers and one positively charged state. To accommodate this increase in states, we represented the neutral states of a HIS residue as two separate residues: HISE and HISδ. If, in the result of the graph-cut algorithm, only one of these states is protonated, then that is the appropriate minimum-energy state. If both HISE and HISδ are protonated, then HIS is fully protonated (in the charged state). The doubly deprotonated state of HIS is excluded; this exclusion is enforced by an infinite interaction energy between the HISE and HISδ states. The energetic differences between HISE and HISδ are calculated in PDB2PKA and currently only include electrostatic interactions with the environment – although it is known that these tautomers are not energetically equivalent in isolation. 45

In order to separate each HIS residue into two separate residues we must define the interaction energy between a separated HIS residue and a non-HIS residue, based on the energies of the non-separated case. We also must define the interaction between two separated HIS residues. The simplest case involves interactions of HIS with a non-HIS residue. The details for constructing the associated energy graph are given in Supporting Information.

Calculation details

The θp values were calculated using Eqs. 3 or 6 based on the lowest-energy state obtained from the graph-cut method. The graph-cut algorithm was written in Python and executed on desktop computer running Macintosh OSX 10.6.8, with two 2.8 GHz 4 Core Xeon E5462 x2 processors with 20GB RAM. The resulting pKa values were compared against the Monte Carlo method in PDB2PKA. Both algorithms were run to calculate titration curves using pH values from 0 to 20 in increments of 0.1.

Test proteins were selected from the PDB by identifying all entries with a single chain, no ligands or modified amino acids, and resolutions below 2.0 Å. The resulting list was then refined by processing through WHATCHECK;46 proteins with errors or excessive warnings were removed from the list. Finally, these proteins were run through the PDB2PKA software. Proteins with excessive energies (typically due to unresolved steric clashes or non-converged electrostatics calculations) were removed from the list. The final list of 82 proteins is provided in the Supporting Information iPython notebook and shows the distribution of proteins with between 11 and 45 titratable residues. We calculated titration curves for each of the titratable residues in 87 different proteins, resulting in 2337 predictions for each algorithm.

Recall that in the case of non-submodular interaction energies, which is typically our setting, we may not be able to label all residues using the graph-cut algorithm. In the cases where we had a significant number of unlabeled residues following the graph-cut method we needed to perform additional optimization. If there are fewer than (or equal to) 20 unassigned residues, we do a brute force search to find the minimum energy state. The “brute force” approach enumerates the 2N (for n unlabeled residues) possibilities to identify the one with the lowest energy. If there are more than 20, we perform a Monte Carlo optimization sampling a subset of the 2N states.

Results

As discussed above, there is a possibility that some residues cannot be assigned titration states due to non-submodular energies. Figure 1 shows the number of residues which were not assigned using the graph-cut method as a function of protein size.

Figure 1.

Figure 1

Distribution (over pH values and proteins) of residues left unlabeled, and thus needing brute force calculation, after applying the graph-cut algorithm.

The graph cut and PDB2PKA titration curves were compared by the mean absolute difference of the titration probability integrated over the pH range:

el1=120020pPDB2PKApGraph cutdpH (8)

with the results shown in Fig. 2. Results for the mean-squared differences are also provided in Supporting Information. Most titration curves show high levels of agreement with less than 5% error. The three curves with the worst agreement (4PGR TYR 167: 11% error, 4PGR ASP 195: 10% error, and 3IDW GLU 51: 7% error) are shown in the iPython notebook in Supporting Information. Further analysis of the few residues which showed large deviation between the PDB2PKA and graph cut titration curves showed very large variations in interaction energies. In particular, the set of all interaction energies between the residue in question and all other residues show a much wider range of energy values than other better-behaved residues. We believe that the significant energy outliers confound probabilistic Monte Carlo sampling and optimization and lead to the poor agreement for these few cases.

Figure 2.

Figure 2

Figure 2

Comparison of titration curves with differences measured by £1 difference between PDB2PKA and graph-cut, as defined in the text (Eq. 8). (A) Distribution of differences across the 2337 titration curves. (B) Distribution of differences for the titratable groups studied in this paper.

The titration curves were used to derive pKas by locating the pH values where the curves crossed 0.5. This approach was used in lieu of Henderson-Hasselbalch fitting because of the coupled titration events observed in several proteins. Our simpler approach is primarily intended to compare the computational methods to each other – rather than generating pKa values for comparison with experiment. Figure 3 compares the pKa values calculated by the graph-cut and PDB2PKA methods. The pKa values are strongly correlated with a Pearson r2 = 0.996, a slope of 1.01, and an intercept of –0.19. A comparison of pKa shifts1 is presented in Supporting Information.

Figure 3.

Figure 3

Comparison of pKa values calculated with the graph-cut method and with PDB2PKA. ○: arginine, □: aspartate, +: C-terminus, ×: glutamate, *: HISE, ◇: HISδ, Δ: lysine, ▽: N-terminus, ◁: tyrosine. Line shows linear fit with p < 0.0001.

Discussion

Our graph-based approach solves an optimization problem to determine the titration state with the lowest energy at a particular pH. This a potential source of error in our prediction of pKa values and titration curves because the titration probabilities should be calculated as thermodynamic averages over the entire ensemble of states. However, Figures 2 and 3 show that the results from our optimization approach and ensemble averages (from PDB2PKA) are very similar. This suggests a scarcity of low-energy states surrounding the titration transitions and is directly related to the accessibility of alternate charge states by thermal fluctuations. This phenomenon was described by Kirkwood and Shumaker47 and continues to be an active area of theoretical and computational investigation. 48 The effects of thermal fluctuations are expected to be largest when the pH is close to the pKa of a site.47,4951 The close agreement between the optimization and Monte Carlo results in Figures 2 and 3 indicate that such fluctuations do not play a major role in the system we studied. However, future work will explore the possibility of using the graph-cut optimization as input to Monte Carlo sampling around the energy minimum to efficiently sample only the most relevant fluctuations.

As described above, residues that violate the modularity condition for titration site interactions are not labeled by the graph cut algorithm and must be optimized by either brute force or Monte Carlo methods. The iPython notebook provided in Supporting Information illustrates the impact of unlabeled residues on execution time. Future research will focus on better understanding the influence of protein structure and energetics on this submodularity and to use more sophisticated optimization methods on the residues not labeled in the graph cut optimization procedure.

Conclusions

Most current titration state prediction algorithms suffer from either performance or sampling issues when searching over the 𝓞 (2N) titration states associated with N titratable residues in a protein system. Sampling issues have historically been a major problem for the PDB2PQR/PDB2PKA Monte Carlo approach for sampling titration states as well as other software packages. This paper presented a new polynomial-time algorithm for optimization of discrete titration states in protein systems. This algorithm was adapted from image processing and uses techniques from discrete mathematics and graph theory to restate the optimization problem in terms of “maximum flow-minimum cut” graph analysis. The interaction energy graph, a graph in which vertices (amino acids) and edges (interactions) are weighted with their respective energies, is transformed into a flow network in which the value of the minimum cut in the network equals the minimum free energy of the protein, and the cut itself encodes the state that achieves the minimum free energy. Because of its deterministic nature and polynomial-time performance, this algorithm has the potential to allow for the ionization state of larger proteins to be discovered.

There are several other problems in macromolecular modeling that require optimization over an exponentially large space of states, including inverse protein folding and design2,52 and rotamer sampling/selection. 53 In the future, we plan to extend this work to some of these other applications. However, the systematic extension of this approach to multi-state systems will be challenging. For example, in order to adapt this work to rotamer selection we need many more than two labels per amino acid and a more generalizable approach for decomposing pairwise interactions between rotamer states. In particular, we need a way of creating a flow network that will allow us to handle any number of labels per amino acid. There has been work in multi-label algorithms for computer vision, 41,43,5456 however they all require that the energy functions satisfy submodularity as introduced earlier in this manuscript. However, algorithms such as α–expansion and αβ-swap which will calculate minimum energy approximations without the need for such restrictions. 43 In future work, we plan to combine these approximations with the non-submodular case discussed in the rest of this paper in order to remove dependency on these energy function conditions.

Supplementary Material

Supplemental data
Supplemental text

Acknowledgements

We gratefully acknowledge NIH grant GM069702 for support of this research, Dr. Jens Nielsen for his work on PDB2PKA, and the National Biomedical Computation Resource (NIH grant RR008605) for computational support.

Footnotes

1

A pKa shift is the difference between the observed pKa value and a model pKa for that residue type.

Supporting Information Available

In a separate supporting information document we provide more details on graph theory formalism, network flows, the creation of the energy graph, normal form, and energy flow network, and reduction of HIS from one amino acid with three states to two interacting amino acids with two states. Additionally we provide all of our data and an iPython notebook in order to reproduce our results, and dig further into the analysis of our algorithms. Finally, we also provide the graph cut Python code which can compute minimum energy states and titration curves using the algorithms described in this paper.

References

  • (1).Godzik A, Kolinski A, Skolnick J. De Novo and Inverse Folding Predictions of Protein Structure and Dynamics. J. Comput.-Aided Mol. Des. 1993;7:397–438. doi: 10.1007/BF02337559. [DOI] [PubMed] [Google Scholar]
  • (2).Yue K, Dill KA. Inverse Protein Folding Problem: Designing Polymer Sequences. Proc. Natl. Acad. Sci. U. S. A. 1992;89:4163–4167. doi: 10.1073/pnas.89.9.4163. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (3).Dahiyat BI, Mayo SL. De Novo Protein Design: Fully Automated Sequence Selection. Science. 1997;278:82–87. doi: 10.1126/science.278.5335.82. [DOI] [PubMed] [Google Scholar]
  • (4).Gordon DB, Marshall SA, Mayo SL. Energy Functions for Protein Design. Curr. Opin. Struct. Biol. 1999;9:509–513. doi: 10.1016/s0959-440x(99)80072-4. [DOI] [PubMed] [Google Scholar]
  • (5).Richardson JS, Richardson DC. The De Novo Design of Protein Structures. Trends Biochem. Sci. 1989;14:304–309. doi: 10.1016/0968-0004(89)90070-4. [DOI] [PubMed] [Google Scholar]
  • (6).Samish I, MacDermaid CM, Perez-Aguilar JM, Saven JG. Theoretical and Computational Protein Design. Annu. Rev. Phys. Chem. 2011;62:129–149. doi: 10.1146/annurev-physchem-032210-103509. [DOI] [PubMed] [Google Scholar]
  • (7).Ponder JW, Richards FM. Tertiary Templates for Proteins: Use of Packing Criteria in the Enumeration of Allowed Sequences for Different Structural Classes. J. Mol. Biol. 1987;193:775–791. doi: 10.1016/0022-2836(87)90358-5. [DOI] [PubMed] [Google Scholar]
  • (8).Ryu J, Kim D-S. Protein Structure Optimization by Side-chain Positioning Via Beta-complex. J. Global Optim. 2013;57:217–250. [Google Scholar]
  • (9).Antosiewicz J, McCammon JA, Gilson MK. The Determinants of pKas in Proteins. Biochemistry. 1996;35:7819–7833. doi: 10.1021/bi9601565. [DOI] [PubMed] [Google Scholar]
  • (10).Bashford D, Karplus M. pKa’s of Ionizable Groups in Proteins: Atomic Detail From a Continuum Electrostatic Model. Biochemistry. 1990;29:10219–10225. doi: 10.1021/bi00496a010. [DOI] [PubMed] [Google Scholar]
  • (11).Bashford D, Karplus M. Multiple-Site Tltration Curves of Proteins: An Analysis of Exact and Approximate Methods for Their Calculation. J. Phys. Chem. 1991;95:9556–9561. [Google Scholar]
  • (12).Handloser CS, Chakrabarty MR, Mosher MW. Experimental Determination of pKa Values by Use of NMR Chemical Shift. J. Chem. Educ. 1973;50:510–511. [Google Scholar]
  • (13).Mosher MW, Sharma CB, Chakrabarty M. Proton Magnetic Resonance of Some Methyl-substituted Pyridines and Pyridinium Ions in Aqueous Solutions. J. Magn. Reson. (1969-1992) 1972;7:247–252. [Google Scholar]
  • (14).Reijenga J, van Hoof A, van Loot A, Teunissen B. Development of Methods for the Determination of pKa Values. Anal. Chem. Insights. 2013;8:53–71. doi: 10.4137/ACI.S12304. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (15).Nielsen JE, Gunner MR, Garcia-Moreno E,B. The pKa Cooperative: A Collaborative Effort to Advance Structure-based Calculations of pKa Values and Electrostatic Effects in Proteins. Proteins. 2011;79:3249–3259. doi: 10.1002/prot.23194. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (16).Yang A-S, Gunner MR, Sampogna R, Sharp K, Honig B. On the Calculation of pKas in Proteins. Proteins. 1993;15:252–265. doi: 10.1002/prot.340150304. [DOI] [PubMed] [Google Scholar]
  • (17).Beroza P, Fredkin DR, Okamura MY, Feher G. Protonation of Interacting Residues in a Protein by a Monte Carlo Method: Application to Lysozyme and the Photosynthetic Reaction Center of Rhodobacter Sphaeroides. Proc. Natl. Acad. Sci. U. S. A. 1991;88:5804–5808. doi: 10.1073/pnas.88.13.5804. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (18).Li Z, Scheraga HA. Monte Carlo-Minimization Approach to the Multiple-Minima Problem in Protein Folding. Proc. Natl. Acad. Sci. U. S. A. 1987;84:6611–6615. doi: 10.1073/pnas.84.19.6611. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (19).Metropolis N, Rosenbluth AW, Rosenbluth MN, Teller AH, Teller E. Equation of State Calculations by Fast Computing Machines. J. Chem. Phys. 2004;21:1087–1092. [Google Scholar]
  • (20).Ozkan SB, Meirovitch H. Conformational Search of Peptides and Proteins: Monte Carlo Minimization with an Adaptive Bias Method Applied to the Heptapeptide Deltorphin. J. Comput. Chem. 2004;25:565–572. doi: 10.1002/jcc.10399. [DOI] [PubMed] [Google Scholar]
  • (21).Ullmann RT, Ullmann GM. GMCT : A Monte Carlo Simulation Package for Macromolecular Receptors. J. Comput. Chem. 2012;33:887–900. doi: 10.1002/jcc.22919. [DOI] [PubMed] [Google Scholar]
  • (22).Wang F, Landau DP. Determining the Density of States for Classical Statistical Models: A Random Walk Algorithm to Produce a Flat Histogram. Phys. Rev. E. 2001;64:056101. doi: 10.1103/PhysRevE.64.056101. [DOI] [PubMed] [Google Scholar]
  • (23).Alder BJ, Wainwright TE. Studies in Molecular Dynamics. I. General Method. J. Chem. Phys. 1959;31:459–466. [Google Scholar]
  • (24).Kantardjiev AA. irGPU.proton.Net: Irregular Strong Charge Interaction Networks of Protonatable Groups in Protein Molecules–A GPU Solver Using the Fast Multipole Method and Statistical Thermodynamics. J. Comput. Chem. 2015:689–693. doi: 10.1002/jcc.23842. [DOI] [PubMed] [Google Scholar]
  • (25).Liwo A, Khalili M, Scheraga HA. Ab initio Simulations of Protein-Folding Pathways by Molecular Dynamics With the United-Residue Model of Polypeptide Chains. Proc. Natl. Acad. Sci. U. S. A. 2005;102:2362–2367. doi: 10.1073/pnas.0408885102. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (26).Meller J. Encyclopedia of Life Sciences. John Wiley & Sons, Inc.; 2001. Chapter Molecular Dynamics. [Google Scholar]
  • (27).Desmet J, de Maeyer M, Hazes B, Lasters I. The Dead-End Elimination Theorem and Its Use in Protein Side-Chain Positioning. Nature. 1992;356:539–542. doi: 10.1038/356539a0. [DOI] [PubMed] [Google Scholar]
  • (28).Hallen MA, Keedy DA, Donald BR. Dead-End Elimination with Perturbations (DEEPer): A Provable Protein Design Algorithm with Continuous Sidechain and Backbone Flexibility. Proteins. 2013;81:18–39. doi: 10.1002/prot.24150. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (29).Kelner JA, Lee YT, Orecchia L, Sidford A. In: Proceedings of the Twenty-Fifth Annual ACM-SIAM Symposium on Discrete Algorithms. Chekuri C, editor. Society for Industrial and Applied Mathematics; Philadelphia, PA: 2014. pp. 217–226. [Google Scholar]
  • (30).Couch V, Stuchebrukhov A. Histidine in Continuum Electrostatics Protonation State Calculations. Proteins. 2011;79:3410–3419. doi: 10.1002/prot.23114. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (31).Antosiewicz JM. Protonation Free Energy Levels in Complex Molecular Systems. Biopolymers. 2008;89:262–269. doi: 10.1002/bip.20837. [DOI] [PubMed] [Google Scholar]
  • (32).Nielsen JE. In: Annual Reports in Computational Chemistry. Wheeler RA, Spellmeyer DC, editors. Vol. 4. Elsevier; 2008. pp. 89–106. [Google Scholar]
  • (33).Wyman J, Gill S. Binding and Linkage: Functional Chemistry of Biological Macromolecules. University Science Books; 1990. [Google Scholar]
  • (34).Popovic D. Modeling of Conformation and Redox Potentials of Hemes and other Cofactors in Proteins. Freie Universitt Berlin; Germany: 2002. Ph.D. thesis. [Google Scholar]
  • (35).Dolinsky TJ, Czodrowski P, Li H, Nielsen JE, Jensen JH, Klebe G, Baker NA. PDB2PQR: Expanding and Upgrading Automated Preparation of Biomolecular Structures for Molecular Simulations. Nucleic Acids Res. 2007;35:W522–W525. doi: 10.1093/nar/gkm276. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (36).Dolinsky TJ, Nielsen JE, McCammon JA, Baker NA. PDB2PQR: An Automated Pipeline for the Setup of Poisson–Boltzmann Electrostatics Calculations. Nucleic Acids Res. 2004;32:W665–W667. doi: 10.1093/nar/gkh381. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (37).Nielsen JE, Vriend G. Optimizing the Hydrogen-Bond Network in Poisson-Boltzmann Equation-Based pK(a) Calculations. Proteins. 2001;43:403–412. doi: 10.1002/prot.1053. [DOI] [PubMed] [Google Scholar]
  • (38).Baker NA, Sept D, Joseph S, Holst MJ, McCammon JA. Electrostatics of Nanosystems: Application to Microtubules and the Ribosome. Proc. Natl. Acad. Sci. U. S. A. 2001;98:10037–10041. doi: 10.1073/pnas.181342398. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (39).Tang CL, Alexov E, Pyle AM, Honig B. Calculation of pKas in RNA: On the Structural Origins and Functional Roles of Protonated Nucleotides. J. Mol. Biol. 2007;366:1475–1496. doi: 10.1016/j.jmb.2006.12.001. [DOI] [PubMed] [Google Scholar]
  • (40).Sitkoff D, Sharp KA, Honig B. Accurate Calculation of Hydration Free Energies Using Macroscopic Solvent Models. J. Phys. Chem. 1994;98:1978–1988. [Google Scholar]
  • (41).Boykov Y, Veksler O, Zabih R. Fast Approximate Energy Minimization via Graph Cuts. IEEE Trans. Pattern Anal. Mach. Intell. 2001;23:1222–1239. [Google Scholar]
  • (42).Kolmogorov V, Zabih R. What Energy Functions Can Be Minimized via Graph Cuts? IEEE Trans. Pattern Anal. Mach. Intell. 2004;26:147–159. doi: 10.1109/TPAMI.2004.1262177. [DOI] [PubMed] [Google Scholar]
  • (43).Veksler O. Efficient Graph-based Energy Minimization Methods in Computer Vision. Cornell University; 1999. Ph.D. thesis. [Google Scholar]
  • (44).Kolmogorov V, Rother C. Minimizing Nonsubmodular Functions with Graph Cuts–A Review. IEEE Trans. Pattern Anal. Mach. Intell. 2007;29:1274–1279. doi: 10.1109/TPAMI.2007.1031. [DOI] [PubMed] [Google Scholar]
  • (45).Bhattacharya S, Sukits SF, MacLaughlin KL, Lecomte JT. The Tautomeric State of Histidines in Myoglobin. Biophys. J. 1997;73:3230–3240. doi: 10.1016/S0006-3495(97)78348-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (46).Hooft RWW, Vriend G, Sander C, Abola EE. Errors in Protein Structures. Nature. 1996;381:272–272. doi: 10.1038/381272a0. [DOI] [PubMed] [Google Scholar]
  • (47).Kirkwood JG, Shumaker JB. Forces Between Protein Molecules in Solution Arising from Fluctuations in Proton Charge and Configuration. Proc. Natl. Acad. Sci. U. S. A. 1952;38:863–871. doi: 10.1073/pnas.38.10.863. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (48).Adžić N, Podgornik R. Charge Regulation in Ionic Solutions: Thermal Fluctuations and Kirkwood-Schumaker Interactions. Phys. Rev. E. 2015;91:022715. doi: 10.1103/PhysRevE.91.022715. [DOI] [PubMed] [Google Scholar]
  • (49).Swails JM, Roitberg AE. Enhancing Conformation and Protonation State Sampling of Hen Egg White Lysozyme Using pH Replica Exchange Molecular Dynamics. J. Chem. Theory Comput. 2012;8:4393–4404. doi: 10.1021/ct300512h. [DOI] [PubMed] [Google Scholar]
  • (50).Itoh SG, Damjanović A, Brooks BR. pH Replica-Exchange Method Based on Discrete Protonation States. Proteins. 2011;79:3420–3436. doi: 10.1002/prot.23176. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (51).Stern HA. Molecular Simulation with Variable Protonation States at Constant pH. J. Chem. Phys. 126. 2007:164112. doi: 10.1063/1.2731781. [DOI] [PubMed] [Google Scholar]
  • (52).Gupta A, Manuch J, Stacho L. Structure-Approximating Inverse Protein Folding Problem in the 2D HP Model. J. Comput. Biol. 2005;12:1328–1345. doi: 10.1089/cmb.2005.12.1328. [DOI] [PubMed] [Google Scholar]
  • (53).Jain T, Cerutti DS, McCammon JA. Configurational-Bias Sampling Technique for Predicting Side-Chain Conformations in Proteins. Protein Sci. 2006;15:2029–2039. doi: 10.1110/ps.062165906. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • (54).Carr P, Hartley R. In: Proc. of the 2009 Digital Image Computing: Techniques and Applications. IEEE Computer Society. Shi H, Zhang Y, Bottema MJ, Lovell BC, Maeder AJ, editors. 2009. pp. 532–539. [Google Scholar]
  • (55).Veksler O. In: EMMCVPR 2009. Cremers D, et al., editors. LNCS 5681. Springer-Verlag Berlin Heidelberg; 2009. pp. 1–13. [Google Scholar]
  • (56).Prince SJD. Computer Vision: Models, Learning, and Inference. Cambridge University Press; 2012. [Google Scholar]

Associated Data

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

Supplementary Materials

Supplemental data
Supplemental text

RESOURCES