Skip to main content

HopDock: a probabilistic search algorithm for decoy sampling in protein-protein docking

Abstract

Background

Elucidating the three-dimensional structure of a higher-order molecular assembly formed by interacting molecular units, a problem commonly known as docking, is central to unraveling the molecular basis of cellular activities. Though protein assemblies are ubiquitous in the cell, it is currently challenging to predict the native structure of a protein assembly in silico.

Methods

This work proposes HopDock, a novel search algorithm for protein-protein docking. HopDock efficiently obtains an ensemble of low-energy dimeric configurations, also known as decoys, that can be effectively used by ab-initio docking protocols. HopDock is based on the Basin Hopping (BH) framework which perturbs the structure of a dimeric configuration and then follows it up with an energy minimization to explicitly sample a local minimum of a chosen energy function. This process is repeated in order to sample consecutive energy minima in a trajectory-like fashion. HopDock employs both geometry and evolutionary conservation analysis to narrow down the interaction search space of interest for the purpose of efficiently obtaining a diverse decoy ensemble.

Results and conclusions

A detailed analysis and a comparative study on seventeen different dimers shows HopDock obtains a broad view of the energy surface near the native dimeric structure and samples many near-native configurations. The results show that HopDock has high sampling capability and can be employed to effectively obtain a large and diverse ensemble of decoy configurations that can then be further refined in greater structural detail in ab-initio docking protocols.

Background

Proteins do not operate in isolation. They achieve their biological function by interacting with one or more molecules to form higher-order assemblies. Structural characterization of protein assemblies (formed by interacting protein units) is central to understanding molecular interactions, designing new effective drugs, and unraveling the molecular basis for different chemical processes in the healthy or diseased cell [1].

There are mainly two predominant experimental techniques to elucidate the biologically-active structure of a protein assembly: X-ray Crystallography and Nuclear Magnetic Resonance (NMR). These techniques are time- and labor-intensive and are often limited by the size of the molecular assembly [2]. The number of protein-protein assemblies with structures deposited in the Protein Data Bank (PDB) [3] is small compared to that of single protein chains. Due to the biological importance and ubiquity of protein-protein assemblies and current limitations of experimental techniques, computational approaches are emerging to complement wet laboratory efforts in elucidating structures of protein assemblies.

When the number of protein units is limited to two, the problem of predicting the biologically-active or native structure formed upon docking of the units onto each other is known as protein docking. This problem is challenging to address in-silico for several reasons. Figure 1 illustrates the docking problem where two unbound units A and B interacts with each other to form a bound configuration. If no a priori information is available, then the problem requires searching over a space of N ∗ M + 6 dimensions. In this space, N and M parameters are needed to instantiate the two protein units in different tertiary structures, and 6 parameters are used to represent the rotation and translation components of the spatial arrangement of one unit onto the other, effectively docking the unit designated as moving onto the one designated as the base.

Figure 1
figure 1

Protein-protein Docking. Two unbound units A and B are docked to form a bound configuration AB through rigid-body motion.

The number of parameters in the general protein-protein docking problem is large, resulting in a high-dimensional search space infeasible for search with systematic approaches. For this reason, many computational approaches elect to reduce the number of parameters by focusing on a sub-problem known as rigid-body docking. In this version of the problem, the tertiary structures of the units are considered to remain the same before and after docking, hence rigid. This effectively does away with the N and M parameters and presents instead a 6-dimensional SE(3) space, which is the space of (rigid-body) spatial arrangements of the moving unit onto the base unit.

Nowadays, many protein-protein docking software and web servers are available, such as pyDock [4], Haddock [2], Zdock [5], ClusPro [6], PatchDock and SymmDock [7], Combdock [8], Budda [9], Rosetta-Dock [10], SKE-DOCK [11], FiberDock [12], and more. As summaries of their performance in the Critical Assessment of PRedicted Interactions (CAPRI) community-wide experiment are showing, their accuracy is steadily increasing. However, these summaries are also elucidating that no method in particular is best at all target assemblies. Moreover, even the top-performing methods on particular assemblies seem to be able to capture only a fraction of the actual interaction interface [13]. Limited sampling capability, inaccuracy of the energy function used to rank an interaction interface, or a combination of both are often cited as possible reasons for current limitations.

Most docking protocols that do not employ any a priori knowledge about the location of the actual interaction interface in the native dimeric structure follow a similar template that consists of two main stages [14]. In stage one, a large ensemble of dimeric configurations is obtained. Scoring functions are used to increase the likelihood that this ensemble contains configurations near the native structure. The ensemble is reduced in preparation for stage two through either scoring functions that employ more detail or through clustering-based techniques that select a subset of the decoys generated in stage one. The selected decoys are possibly added more structural detail, refined at length through more computationally-intensive energy minimization techniques to make final predictions on which decoys best represent the sought native structure. In some protocols, flexibility is considered to improve the quality of the selected decoys and possibly get closer to the native structure [2]. An important component of the success of this two-stage protocol is the ability of the search algorithm employed in stage one to obtain a relevant ensemble of decoys and not miss the region near the native structure.

The focus of this work is on enhancing sampling of relevant regions in the dimeric configuration space to obtain a diverse decoy of ensemble that can then be analyzed and further refined in energetic detail in the context of ab-initio docking protocols. Towards this goal, we propose here a novel probabilistic search algorithm, HopDock. HopDock samples dimeric configurations that are local minima of some energy function employed to rank interaction interfaces. However, HopDock does not spend its entire computational time operating on the energy surface, which would be computationally demanding. Instead, HopDock elects to operate on the energy surface only to refine configurations that are obtained to align putative interaction interfaces. It is important to note that the definition of a putative interaction interface in this work builds over both the body of geometry-based methods for docking, summarized above, and our own previous work that extends this definition to include evolutionary conservation. In [15, 16], we have shown in simple settings of Metropolis Monte Carlo random walks that geometric complementarity and evolutionary conservation are key to narrowing the search space of interest to only a few subspaces shown to include known interaction interfaces in dimers. We build here over this body of work, proposing a more powerful probabilistic search framework that uses this information in a computationally-viable manner. The framework conducts all its global search on regions of SE(3) deemed to contain putative interaction interfaces. Its local search component spends time to further refine interaction interfaces with a simple physics-based energy function.

HopDock is an evolutionary search algorithm and can be considered an algorithmic realization of the Basin Hopping (BH) (or Iterated Local Search) framework [17] (hence, the name HopDock). Our adaptation of the BH framework in HopDock focuses on efficiently navigating the reduced search space (of putative interaction interfaces) to obtain an ensemble of bound configurations corresponding to local minima of a given energy function. Since the focus in this work is on proposal and analysis of effective components in the BH framework for protein docking, the energy function considered here is a simple one consisting of basic physics-based terms.

Our inspiration to build over the BH framework comes from recent findings in the computational structural biology community, including our own preliminary investigation in [18]. Though the BH framework was first proposed to compute structurally-diverse Lennard-Jones minima of small clusters of atomic particles, it has now been shown promising in obtaining low-energy decoy configurations in the context of ab-initio protein structure prediction, where the goal is to predict the structure of a single protein chain in isolation [19–25]. At the core of the BH framework lies a repeated application of a structural perturbation of a configuration followed up by an energetic refinement or minimization of the resulting configuration to obtain a trajectory of low-energy local minima. A Metropolis criterion [26] is used to bias the growing trajectory of consecutive minima towards lower-energy regions of the energy surface.

Our adaptation of the BH framework in HopDock focuses on effective implementations of the perturbation and minimization components that make use of the underlying SE(3) search space. For example, the structural perturbation in HopDock builds over the basic process of aligning geometrically-complementary and evolutionary-conserved regions on the molecular surfaces. The minimization component uses the simple energetic scheme to further optimize a configuration resulting from the structural perturbation.

A preliminary proof-of-concept implementation of this BH-based exploration of dimeric configuration spaces has been presented in [18]. Here we present a more general framework, where we additionally investigate, for instance, the relationship between strength of evolutionary conservation and the ability of the algorithm to capture the correct interaction interface in its ensemble of decoy configurations. Moreover, a detailed analysis over different implementations of the perturbation and minimization components is also carried out in this paper to obtain effective implementations of these components in HopDock. HopDock is benchmarked on a broad and diverse list of protein dimers with known native structures. A detailed comparative analysis places HopDock in the context of other search algorithms used in docking protocols. Our results suggest that HopDock is efficient, competitive, and samples many near-native configurations. These characteristics make it a promising search algorithm to use in the context of docking protocols, particularly if more powerful energy functions are used and if the generated decoys are further selected and refined at greater detail and with more computational resources [27, 28].

The rest of this article is organized as follows. We first provide a review of related work in order to place HopDock in context. Details on the different components of HopDock are provided in the Methods section. The Results section evaluates these components on seventeen diverse protein dimers and further compares the result of HopDock to those reported or obtained by current state-of-the-art docking protocols. The Conclusions section provides a discussion and offers promising directions of future research.

Related work

Current docking methods can primarily be categorized into two approaches, energy-based and geometry-based. Methods like pyDock [4], RosettaDock [10], ClusPro [6], and Haddock [2] take an energy optimization approach. The optimization seeks minima of a defined energy function. If the energy function is sufficiently accurate, near-native configurations will be found among the lowest-energy minima [6, 13]. In docking protocols, the process is usually split into two stages. In the first stage, a search is conducted to obtain a large number of low-energy bound configurations. The focus on the size of the ensemble is partially due to the fact that current energy functions are not accurate. Indeed, if only the lowest-energy minimum is maintained in the ensemble, the native structure will certainly be missed by many Ångströms (described in Results section). The size of the ensemble makes it impractical to employ a lot of structural detail and use expensive energy functions. For this reason, typically, the large ensemble is obtained with a simple scoring function. The ensemble is reduced through selection techniques, often relying on structural clustering, to obtain a subset that can be afforded to be optimized in greater structural detail and with more expensive scoring functions in stage two. Computational time can even be devoted in this stage to incorporate some flexibility around detected interfaces in the bound configurations [12].

RosettaDock is a representative of current protocols. The optimization in RosettaDock is carried out over rigid-body orientations and side-chains, followed by continuous minimization. pyDock is another optimization-based server for accurately scoring rigid-body motions. In the first stage, pyDock uses FT-DOCK [29], a Fast Fourier Transform-based docking algorithm, for rigid-body docking. Configurations are then evaluated by their binding energy based on electrostatic and desolvation to obtain a relevant subensemble. As in pyDock, the first stage in ClusPro is performed using a Fast Fourier Transform-based docking algorithm known as DOT [30]. In preparation for stage two, configurations are filtered using a combination of desolvation and electrostatic energies. A clustering algorithm is applied to discriminate against false positives and reduce the set of configurations to near-native structures. Haddock [2] is another example of an energy-based docking protocol that makes use of biochemical data available from NMR to reduce the search space where possible.

Even if computational resources are considered unlimited for optimization, research shows that it remains challenging to design energy functions to accurately score native interaction interfaces [13, 31]. For this reason, a group of docking methods take a complementary approach that delays energy considerations to the extent possible.

Instead of conducting the search over a large continuous space, some methods like Budda [9], CombDock [8], PatchDock, SymmDock [7], ZDOCK [5], and LZerD [32] discretize the space by defining geometrically-complementary regions on the molecular surfaces of the units participating in the assembly. The process of searching for arrangements that take one unit over the other then becomes searching for rigid-body transformations that align a region of one molecular surface with a complementary region of the other molecular surface. The main basis of this geometric treatment is that molecules are more likely to interact along geometrically-complementary regions on their surfaces. Convex regions fit better in concave ones, which should produce more stability for docked configurations that superimpose geometrically-complementary regions.

In order to model geometric complementarity, the molecular surfaces of the unbound units need to be analyzed and summarized in terms of geometric properties. Several numerical methods quantize and represent molecular surface with a collection of points, most notably the Connolly [33] and Shuo methods [34]. These methods summarize a molecular surface in terms of "critical" points that contain information on whether the surface region they represent is convex, concave, or saddle. This information is used to consider only rigid-body transformations that align geometrically-complementary regions (such as convex with concave).

The search for geometrically-complementary surface regions is conducted through mainly two approaches. A traditional grid-based shape complementary approach like FTDock [29] identifies grid points surrounding the base unit and the total number of grid points overlapping any grid points corresponding to the moving unit. A more accurate and detailed computer vision-based technique known as Geometric Hashing [35] uses transformation-invariant representations of the molecular surface which allow direct matching. It takes as input a database of objects and a scene in which to find the objects. The algorithm consists of two stages, preprocessing followed by recognition. During the preprocessing stage, some features of the base unit are extracted and hashed into a table. The recognition stage similarly extracts related features from the moving unit and then matches those features to those of the base unit stored in the hash table.

CombDock [8] is based on the technique of Geometric Hashing (GH). In the first stage, CombDock matches geometrically-complementary regions on molecular surfaces. Promising configurations are then subjected to the filtering stage, which uses both geometry and physico-chemical features to identify promising decoys without any use of a detailed energy function. LZerD [32] also uses Geometric Hashing for shape matching in the first step and incorporates a novel geometry-based scoring function using 3D Zernike descriptors in the final step. Multi-LZerD, a recent algorithm for protein assemblies of more than two units [36] uses LZerD for pairwise docking and then relies on a genetic algorithm to sample multimeric configurations. The multimeric decoys are ranked with a physics-based scoring function. Other techniques, like VASP [37], do not carry out explicit docking, but propose useful volumetric-based analysis and representations of surface cavities, clefts, and tunnels to rank and compare binding interfaces.

Due to the implicit discretization of the search space, geometry-based approaches are more efficient but also less accurate than energy-based approaches. Thus, geometry-based approaches are useful to obtain many decoys in an efficient manner. Optimization can be delegated to subsequent stages. Indeed, since their introduction, they have demonstrated that they feasibly produce decoy configurations that then, through further energetic refinement, reproduce biologically-relevant native assemblies [38]. The HopDock algorithm we propose in this paper can be considered to fall in this category, using a simple energy function to refine dimeric configurations found by essentially matching geometrically-complementary regions. In addition, HopDock only explores subspaces of SE(3) of potential interest by narrowing the definition of a putative interaction interface to one that matches both geometrically-complementary and evolutionary-conserved surface regions. We now relate details on the HopDock algorithm.

Methods

We now relate detail on the HopDock algorithm. As mentioned in the Introduction section, a preliminary proof-of-concept implementation of the BH framework realized in HopDock has been presented in [18]. Our description of HopDock focuses on the overall approach and the novel components added to it in this paper. However, for the sake of completeness, we summarize the components of the preliminary presentation in [18].

In summary, HopDock is based on the BH framework, and the search in it is guided by a simple energy function. The search is conducted over rigid-body transformations that align interfaces that are both geometrically-complementary and evolutionary-conserved. Though these two criteria do not guarantee finding the native interaction interface, they do allow narrowing the search for dimeric configurations to those that align credible interfaces. Geometric complementarity is a well-established predictor for true contact interfaces. Moreover, a detailed analysis in the Results section shows that focusing on evolutionary-conserved regions not only helps finding the correct interaction interface, but more evolutionary-conserved regions are on the native interaction interface than elsewhere on the molecular surface.

Details of the proposed algorithm are presented as follows. First, we define the search space by describing in detail how we use the geometry and evolutionary conservation information to detect rigid-body transformations of interest. Second, we describe a simple energy function that can rank a bound configuration resulting from applications of such a rigid-body transformation. Third, we relate details on how all these elements are incorporated in the proposed HopDock algorithm.

From molecular surfaces to rigid-body transformations

We now describe how molecular surfaces are analyzed and represented in order to define rigid-body transformations that align chosen surface regions of the units being docked onto each other. Our criteria for choosing certain surface regions are geometric complementary and evolutionary conservation, as detailed below.

From molecular surfaces to critical points

The predominant representation of a molecular surface is the Connolly Surface representation [33]. The Connolly method places a probe ball, representing the solvent molecule, tangent to the atoms of the molecule on thousand different locations. For each position of the ball, the point that does not overlap with the van der Waals radii and points facing the inward-surface of the probe becomes part of the molecular surface. The 3D coordinates of each such point are maintained in the Connolly representation of the molecular surface, together with the normal vector and a numeric value to indicate the geometric type of the point. The type ranges from convex, saddle, to concave, and is determined based on the tangency of the probe to the number of atoms on the molecular surface.

The Connolly representation is dense. A sparse representation can be calculated instead [34] that consists of critical points. These are defined as the maxima or minima of a Connolly face of a molecular surface. Critical points are referred to as "caps", "pits," or "belts" to represent the center of gravity of the convex, concave, and saddle surface of the Connolly representation, respectively. The collection of critical points is sufficient and complete to cover key locations of the molecular surface. This sparse representation reduces the total number of points from the high number of points generated by the Connolly surface and so reduce the costs of a geometric treatment in rigid-body docking.

From critical points to active critical points: an evolutionary conservation analysis

We now introduce the notion of an active critical point by additionally considering an evolutionary conservation analysis of the molecular surface.

Several studies have shown that molecular regions making up actual interaction interfaces are more evolutionary conserved, probably as a result of higher pressure to retain functional integrity during evolution [39]. Some amino acids are bound to remain more conserved throughout evolution than others if they are involved in an interaction interface. Thus, evolutionary conservation can be a good predictor of the native interaction interface. Several methods [40], [41] now exist for rigorous evolutionary analysis of protein sequences that allow associating evolutionary conservation values with each amino acid of a protein of interest.

The evolutionary analysis method known as Joint Evolutionary Trace (JET) [40], which we employ in this work, allows associating conservation scores with each amino acid of a protein chain. JET relies on multiple sequence alignment and provides rates of conservation known as trace scores. Each amino acid is associated its own trace score in JET. The score is in the [0.0 - 1.0] range corresponding to the least conserved to the most conserved spectrum. We have used iterative JET (iJET), which essentially repeats the JET analysis n times to associate a more reliable (average) conservation score with each amino acid. After obtaining such scores, a threshold score conserve th is then used to designate an amino acid as conserved or not conserved. The determination of the value of this parameter and its role in narrowing the focus to the correct interaction interface while not discarding it, is detailed in Results section.

The obtained evolutionary scores can be transferred to critical points. Specifically, a critical point is assigned the conservation score of the surface amino acid closest to it. A critical point with a conservation score greater than conserve th is deemed to be "active" as opposed to "passive." The active/passive designation is inspired by work in [2]. As we detail below, active critical points are used to define surface regions of interest for alignment.

From active critical points to active triangles

We now describe how active critical points are used to build active triangles for matching during docking. For any rigid-body motion, a reference frame needs to be defined. In this work, reference frames are defined in terms of active triangles on molecular surface as follows: three critical points are used to define a triangle. At least one of these points has to be active for the triangle to be designated active, as well. First, given the threshold conservation score conserve th , a critical point is chosen whose conservation score is above the threshold. Let us refer to this point as p 1.

Given p 1, two more critical points (let us refer to them as p 2 and p 3) need to be specified in order to define a triangle. The two other points do not have to be necessarily conserved in our definition of an active triangle, as long as one point (served by p 1) is. The only criteria in selecting p 2 and p 3 is that they have to satisfy angle and distance constraints. Satisfaction of angle constraints is needed so that the points are not collinear and a triangle can indeed be defined. The distance constraints ensure that the resulting triangle is not too small or too large and are based on the ones originally put forth in [38]. A minimum distance of 2.0Ã… is used so that points are not within this distance of one another (so not on th same van der Waals - vdw - radius of an atom). The maximum distance of 5.0Ã… ensures the resulting triangle does not cover too much of the molecular surface.

We narrow our focus to unique active triangles in order to limit the number of attempted transformations aligning geometrically-complementary active triangles and avoid redundancy as in [15, 16]. A triangle's vertices are first subjected to a lexicographic ordering, which is used to ensure that no two triangles share their first vertex. Further, triangles are hashed by their center of mass in order to ensure that no two triangles share their center of mass. The result of all these constraints is that less than n active triangles are defined given n critical points.

From active triangles to rigid-body transformation

First, one of the units, let's say A, is arbitrarily selected as the "base" unit. Therefore, the other unit B will be the "moving unit". For each unique active triangle selected from A, a matching active triangle is selected from B. The features considered for matching two active triangles are only geometric. Suppose the two selected triangles are tr A and tr B . The rigid-body transformation superimposing triangle tr B over triangle tr A according to 1, will align the monomer B on monomer A, resulting in a particular dimeric configuration. Thus, a new dimeric configuration is the result of a rigid-body transformation using active triangles.

T = t r B ′ * t r A
(1)

where t r B ′ defines the inverse of reference frame tr B .

Energy function

HopDock uses a simple energy function to quickly sample low-energy dimeric configurations to get a broader view of the local minima in energy minimization component. Suppose HopDock has obtained a new dimeric configuration through a rigid-body transformation that aligns two active triangles (one on each unit). We use the following simple energy function to guide the search in HopDock towards configurations that represent minima of this energy function:

E = E v d W + E e l e c t r o s t a t i c + E h y d r o g e n - b o n d i n g .
(2)

The first two terms measure vdw and electrostatic interactions and are based on the CHARMM22 force field [42]. Specifically, the vdw term is based on the standard 12-6 Lennard-Jones potential as follows:

E v d W = ∑ a t o m p a i r s ε [ ( r i j d i j ) 12 - 2 × ( r i j d i j ) 6 ]
(3)

where r ij is the atomic radii sum, E is the energy well depth derived from CHARM22 [42], and d ij measures the Euclidean distance between atoms i and j. This energy term penalizes collisions between atoms on one unit and atoms on the other unit in the bound configuration. Atomic pairs (one atom on each unit) that lie not only closer but also farther than an ideal distance (determined by atom types) are also penalized.

The electrostatic term is computed based on Coulomb's law:

E e l e c t r o s t a t i c = ∑ a t o m p a i r s q i × q j e × d i j 2
(4)

where q i and q j are the electrostatic charges of atoms i and j obtained from CHARM22 [42], e is the dielectric constant (vacuum constant 1 is used for this paper), and d ij is the distance between atoms i and j. The purpose of this term is essentially to penalize atomic pairs that bring similar charges.

The hydrogen-bonding term is calculated through the 12-10 hydrogen potential [43] as follows:

E h y d r o g e n - b o n d i n g = 5 × ( r 0 d i j ) 12 - 6 × ( r 0 d i j ) 10
(5)

where d ij measures the Euclidean distance between the interface acceptor atom i and interface donor j. Here, r 0 = 2.9Ã… is the idealized distance for hydrogen bonding. The purpose of this term is to reward formation of possible hydrogen bonds between atoms in an interaction interface.

HopDock: a BH-based algorithm sampling low-energy configurations of dimeric protein assemblies

As in the BH framework, HopDock computes a trajectory of n configurations C 1, ..., C n that correspond to minima of a chosen energy function through the BH framework. The general BH framework is illustrated in Figure 2. Starting from a configuration C 1 sampled at random (obtained through a rigid-body transformation aligning sampled geometrically-complementary active triangles), HopDock hops between two consecutive configurations in the trajectory, C i and C i+1, through an intermediate configuration C perturb,i. A structural perturbation component in HopDock modifies C i to obtain a configuration C perturb,i that allows escaping the current minimum represented by C i . The minimization component follows the perturbation. The minimization consists of a series of structural modifications, initiated at C perturb,i, to obtain a new energetically-refined configuration C i+1representing the energy minimum nearest to C perturb,i. The resulting C i+1configuration is added to the growing trajectory only if it passes the Metropolis criterion. This criterion is based on the difference in energy between C i (the previous minimum in the trajectory) and C i+1(the current configuration considered a candidate for the new minimum) and an effective temperature serving as a scaling parameter as in e-[E(C i+1)-E(C i )]/T e . The objective is for the trajectory of energy minima to converge to lower-energy minima over time. In the Results section, we detail and analyze the effect of different temperature values to select an effective temperature that allows enhancing the sampling of low-energy minima near the native dimeric configuration.

Figure 2
figure 2

Overview of Basin Hopping Framework. Under the BH framework, the energy surface is transformed into a collection of interpenetrating staircases. A trajectory of local minima is obtained consecutively, through iterated applications of a structural perturbation to jump out of a current local minimum and an ensuing local optimization to map to another nearby local minimum.

Structural perturbation

The perturbation component structurally modifies the current minimum configuration C i by seeking a new rigid-body transformation to obtain C perturb,i. A naive implementation would not maintain a correlation between the contact interface in C i and that in C perturb,i. We compare to a naive implementation in Results section and show that preserving some (but not too much) of the contact interface of C i in C perturb,i is important in obtaining good-quality decoy configurations. We do so by essentially limiting the search for a new contact interface in C perturb,i to surface regions near the contact interface in C i . We limit the neighborhood over which new active triangles are sought for matching to obtain C perturb,i. This is based on studies showing that a perturbation jump of magnitude not too small and not too large results in successful applications of the BH framework for molecular modeling [22–24, 44].

Given the current minimum C i , a dimeric configuration C perturb,i that preserves some of the good structural characteristics of C i is obtained as follows. Let us refer to the two active triangles that are used to define the rigid-body transformation resulting in the current minimum C i as {tr A , tr B } (one from each monomer). The perturbation component samples a new active triangle t r A ′ over the surface of unit A uniformly at random in a d-neighborhood of tr A . Here d refers to the distance, in angstroms, between the center of mass of tr A and t r A ′ . Given the newly sampled t r A ′ , a new active triangle t r B ′ is sampled over a d-neighborhood of tr B uniformly at random. This process is repeated until a pair of geometrically-complementary active triangles t r A ′ and t r B ′ is found. Once these triangles are obtained, a new rigid-body transformation aligning them is defined (as described above), resulting in the perturbed dimeric configuration C perturb,i.

Small values of d will ensure that C i and C perturb,i are close in configuration space and so share structural features and parts of their contact interfaces. However, such values may result in no geometrically-complementary active triangles. Large values of d increase the probability that a geometrically-complementary pair will be sampled, but they also result in C i and C perturb,i potentially being far away in configuration space. When that happens, our adaptation of BH in this algorithm degenerates to essentially minimization with random restarts. In the Results section we show the effect of two values of d on the magnitude of the perturbation jump and the ability of our algorithm to sample minima near the native configuration. We additionally demonstrate that controlling the value of d to some not very large value yields better results than a simple framework that follows up random restart with minimization (where d is essentially infinite).

Local optimization: energy minimization

The minimization component modifies the perturbed configuration C perturb,i to obtain a new nearest energy minimum C i+1. The minimization essentially attempts to correct structural features that the perturbation component changed from C i in C perturb,i and so compute new good features resulting in another energy minimum C i+1. The minimization component in this paper carries out at most m consecutive structural modifications, starting with C perturb,i until k consecutive modifications fail to lower energy. Two different implementations are pursued in this paper, depending on how the structural modifications are defined. One straightforward implementation is to define each of these modifications essentially as versions of the perturbation component, but with smaller d. The purpose of making d small is so that the minimization brings C perturb,i to the nearest local minimum and not to some random point in the configuration space.

Our analysis shows that it can be hard to find small values of d that will still allow finding geometrically-complementary active triangles. Therefore, this implementation is not effective, as it tends to make large jumps in configuration space all the while attempting to lower energy. Therefore, a new implementation is pursued for the minimization component. This implementation essentially samples new rigid-body transformations directly, rather than through active triangles, in a continuous neighborhood of an initial transformation.

A rigid-body transformation is represented as 〈t, u, θ〉, where t specifies the translation component, and 〈u, θ〉 specify the orientation component in an axis-angle representation (implemented here through quaternions). In each modification in the minimization component, a new random transformation is sampled in the neighborhood of the transformation representing the configuration resulting from the previous modification. The translation and rotation components are sampled individually. A new translation component is sampled in a δ t neighborhood of t. A new rotation component is obtained by sampling a new axis u rotating around the axis u by a sampled angle value δ ϕ ; a new angle is obtained by sampling in a δ θ neighborhood around θ.

The implementations we propose for the minimization component do not seek to identify the true basin of a local minimum. The depth of the exploration is determined by the parameter m in the minimization. Given that the decoys need to be low-energy but can be refined in detail at a later stage, this approximate definition of a local minimum is sufficient. For this reason, the minimization component employs a simple energy function.

Results and discussion

The organization of this section is as follows. The implementation details and the protein systems employed here for validation of HopDock are described first. Second, an analysis of the distribution of evolutionary-conserved regions on the molecular surface in finding the true interaction interface is presented in the next section. The next few sections provide a detailed analysis on how values of different parameters in HopDock have been chosen. The parameters analyzed here are the evolutionary conservation threshold, the effective temperature T e employed in Metropolis Criterion, the perturbation distance d in the perturbation component, and the translation distance t in the minimization component. In the following section an analysis has been performed to investigate the relationship between the lower energy values to the near-native structures. A detailed comparative analysis on the attainment of the known native configuration for the proteins systems studied in this work to other state-of-the-art docking protocols is provided in the last section.

Experimental setup

Implementation details

HopDock was run on a 3GHz of Opteron Processor with 4GB of memory to generate 10, 000 dimeric configurations per protein system considered. A detailed analysis of HopDock was conducted on 5, 000 to 20, 000 configurations. Results obtained with r 10, 000 configurations were found to be representative, so the analysis presented below is over 10, 000 sampled configurations. Depending on the size of the protein systems under investigation, obtaining this number of configurations takes anywhere from 1 - 12 hours on one CPU.

Performance measurements

Our analysis employs least Root-Mean-Square-Deviation (lRMSD) to the known native dimeric structure to determine the quality of a generated configuration. lRMSD is a widely accepted performance measurements in docking methods, reported in units of Ångström (Å). RMSD is a measure of the average atomic displacement between two configurations, say x and y, under comparison and is calculated as follows:

1 N ∑ i = 1 N | | x i - y i | | 2
(6)

lRMSD refers to the minimum RMSD over all possible rigid-body motions of one configuration relative to the other. A value between 2 and 5Ã… is considered to be indicative of a configuration being highly similar to the known native structure, and the configuration is deemed near-native. We use lRMSD here not only to determine the proximity of dimeric configurations generated by HopDock to the known native structure but also to analyze the proximity of configurations to each other in the trajectory generated by HopDock.

Protein systems of study

We have selected seventeen different dimers with known native structures obtained from PDB as our systems of study. These dimers, listed in Table 1 are chosen because they vary in size, functional class, and have been studied by other docking methods, as well. Table 1 lists the PDB ID of the known native structure of each dimer in column 1, the size of each unit in a dimer in terms of number of atoms in column 2, and the known functional classification obtained from PDB in column 3. Systems that are CAPRI targets are marked with an asterisk in column 1.

Table 1 Protein systems of study.

Evolutionary conservation analysis preserves native interface

The role of evolutionary conservation in finding the true contact interface has been demonstrated in other studies [45, 46]. The work in [45] shows good correlation between sequence conservation and inclusion of conserved surface regions in the interaction interface. The analysis in [45] was expansive, classifying 265 proteins into different functional categories and measuring the correlation between conservation and inclusion of conserved regions in the interaction interface through Matthews' correlation coefficient (MCC) [47]. Analysis of MCC values allowed concluding that interaction interfaces in signal proteins and enzymes was particularly conserved. A larger dataset of 2646 protein interfaces was analyzed in [46]. The study concluded that not only there are highly conserved surface regions on the majority of proteins, but also in most proteins these regions are more likely to be found on interaction interfaces than on the rest of the molecular surface.

We conduct here a similar analysis to that in [46] to investigate the relationship between the known interaction interface and evolutionary-conserved regions based on our working definition of active critical points (described in Methods section). The goal is to uncover any correlation between high evolutionary conservation score and the true contact interface. We point out that our analysis is confined to the 17 systems studied in this work, 8 of which were specifically chosen due to their inclusion in the study in [46]. We measure two different ratios, R interface and R rest on each of the known native dimeric structures of the systems studied here. R interface is the ratio between the number of conserved critical points on the known interaction interface to the total number of critical points on that interaction interface. R rest is 1 - R interface . Two critical points, one from the molecular surface of unit A and the other on that of unit B in known native dimeric structure, are considered to be in contact and thus in the true interaction interface if their Euclidean distance is no higher than 5Ã…. This distance threshold is commonly employed in other work [2, 5].

Each of the ratios described above is measured as a percentage, and the difference between them, R rest - R interface , is plotted in Figure 3 in column diagram format. A negative value indicates that the interaction interface is more conserved than the rest of the surface, as more of the active critical points fall in it rather than elsewhere on the molecular surface. Results are shown for three different conservation thresholds in {0.25, 0.50, 0.75} in different colors to visualize the effect that varying the conservation threshold has on the distribution of conserved critical points.

Figure 3
figure 3

Analysis of Evolutionary Conservation. Column diagram shows the R rest - R interface difference on each of the seventeen dimers. Three different conservation thresholds are considered and results for each are shown in different colors. Negative percentages indicate the interface is more conserved than the rest of the molecular surface.

The results in Figure 3 allow concluding that in 10 of the 17 dimers, the distribution of conserved critical points is heavily concentrated on the true interaction interface as opposed to the rest of the molecular surface. In the context of employing this information for docking, this result means that more rigid-body motions will focus on matching regions on the actual interaction interface than elsewhere on the molecular surfaces. On the rest of the dimers, Figure 3 shows that the difference is not too large, which means HopDock will not spend a large portion of its time on matching regions elsewhere on the molecular surface rather than on the known interaction interface.

Analysis of different parameter values employed in HopDock

Here we investigate in detail the effect that varying values of certain parameters in HopDock has on the quality of the ensemble of sampled dimeric configurations. The parameters we investigate are the conservation threshold and its effect on the size of the search space, the effective temperature employed in the Metropolis criterion and its effect on the energetic and structural quality of sampled configurations, and the perturbation distance in the perturbation component and translation distance in the minimization component and their effect on the overall quality of the sampled ensemble.

Analysis of evolutionary conservation threshold

Analysis on the choice of the conservation threshold, conserve th , is presented in Table 2 on three selected systems that considers the same three different thresholds as in Figure 3. The results of this table are obtained through our previous work [15, 16]. The analysis focuses on showing the effect of different evolutionary conservation thresholds on the number of active triangles and essentially on the lowest lRMSD to native that can be achieved. Column 1 indicates the PDB ID of these three systems and their chains in brackets. Three conservation thresholds in {0.25, 0.5, 0.75} are employed to define three sets of active triangles and are reported in column 2. Column 3 shows the number of active triangles defined on the molecular surface of the base/reference unit under each conservation threshold. For each system, three sets of dimeric configurations, one for each threshold, are then obtained from our previous work. The lowest lRMSD to the experimentally-determined native structure from these dimeric configurations is recorded for each set and these values are reported for each system in column 4. The last column shows R rest -R interface recorded for each conservation threshold as from Figure 3.

Table 2 Conservation threshold analysis.

Table 2 highlights a few results. First, the number of active triangles decreases as the conservation threshold increases. This is expected, since a higher threshold limits the number of active critical points which in turn limit the number of active triangles. Second, the lowest lRMSD generally decreases as the conservation threshold increases, but the effect on lRMSD depends on how much of the conserved critical points under each conservation threshold remain on the true interaction interface as opposed to elsewhere. These results, combined with our analysis on the distribution of conserved critical points on the molecular surface above, allow us to conclude that a conservation threshold of 0.5 is a reasonable compromise between maintaining a smaller number of active triangles, thus reducing the size of the search space, while retaining the known interaction interface. For this reason, the rest of our experiments employ conserve th = 0.5 as conservation threshold.

Analysis of effective temperature

The effective temperature T e in the Metropolis criterion affects the acceptance probability e-δETe with which an energetic increase δE is accepted in the trajectory. A higher temperature increases the probability to accept an energy increase between two consecutive configurations in the trajectory than a lower temperature. A high temperature will allow HopDock to make large jumps in the energy surface, effectively degenerating to a random restart search where there is no correlation between two consecutive configurations in the HopDock trajectory. On the other hand, a low temperature may provide too strong a bias and not allow HopDock to accept temporary energetic increases to potentially cross energy barriers needed for convergence to deeper local minima over time.

In [18], we compare various effective temperatures and their effect on two measures of performance, lowest lRMSD to the native structure and percentage of configurations with lRMSD < 5Ã… to the native structure. The analysis focuses on two representative temperatures, T 0, a representative of a medium temperature and T 1, a representative of a lower temperature. T 1 allows accepting an energy increase of 2 kcal/mol with probability of 0.39, allows accepting that same energy increase with a lower probability of 0.16. The analysis presented in [18] allows concluding that T 0 allows HopDock to generate slightly more near-native configurations than T 1 does. The lower temperature T 1 allows achieving lower energies, as expected, but these do not necessarily translate to near-native configurations when dealing with inaccurate energy functions. Based on this analysis, we have chosen the higher temperature T 0 to allow more energetic diversity for the rest of the experiments in the Metropolis criterion that guides the acceptance of local minima sampled by HopDock.

Analysis of perturbation and minimization distance

The next experiment compares different implementations of the perturbation distance d described in the Methods section. The first implementation essentially allows testing the efficacy of random restart. In this implementation, a geometrically-complementary pair of triangles is sampled uniformly at random, and the resulting transformation is applied to obtain a new perturbed configuration. This implementation essentially refers to the case when d = ∞, since it employs no knowledge of the pair of triangles that were aligned to obtain the previous minimum C i . In the second and third implementations, d is controlled and set to 7 and 5Å, respectively. A smaller value of d makes it very hard to find geometrically-complementary triangles on the molecular surfaces.

Our preliminary investigation in [18] compares these three different implementations in terms of various statistics. First, the distance in terms of lRMSD between two consecutive perturbed configurations, C perturb,i and C perturb,i+1 is recorded to obtain a measure of the magnitude of the perturbation jump in each setting. Let us refer to this distance as l. The median over these distances over all perturbed configurations obtained in the process of running HopDock with each of the three implementations of the perturbation component, l m is also tracked. The actual distribution of these distances is investigated in more detail by tracking the percentage of distances in the 0-5Å and 5-10Å range. The effect of controlling d is also evaluated in terms of the quality of the overall ensemble of sampled minima by measuring the lowest lRMSD to the native structure and the percentage of minima configurations with lRMSD to the native structure less than 5Å. All these measurements are compared across the three settings of d ∈ {∞, 7, 5}Å, and our detailed analysis in [18] allows concluding that d = 5Årepresents an optimal setting. We highlight the most salient conclusions of that analysis in Figure 4. We show in Figure 4(a) that controlling d allows controlling the median distance l m . Additionally, Figure 4(b) shows that lowering d also increases the number of consecutive perturbed configurations with < 5Å of each-other. The full analysis in [18] shows this is also true for perturbed configurations with < 10Å lRMSD of each-other, and that lowering d does not impact the number of minima with low lRMSDs to the native structure negatively. For this reason, we employ d = 5Å in the rest of our experiments below.

Figure 4
figure 4

Analysis of Effect of Perturbation Distance. The effect of perturbation distance on three representative systems is shown here to summarize the detailed analysis in [18]. Three different values of d are considered, ∞, 5Å and 7Å, color-coded in different colors. The bars in the top pannel (a) show the median l m of the l distribution of lRMSDs between two consecutive perturbed configurations. Those in the bottom pannel (b) show the percentage of consecutive distances within 5Å of each-other.

Finally, our preliminary investigation in [18] also pitches different implementations of the minimization component against one another. In all implementations, m = 100 and k = 20 (i.e., the minimization trajectory initiated from a perturbed configuration is at most 100 steps long and can terminate earlier, if 20 consecutive steps all fail to lower energy). In the Methods section we explain that the consecutive modifications pursued in the minimization component to lower interaction energy can be considered versions of the perturbation component with d = 5Å. However, these result in large moves in the minimization component and do not ensure that a perturbed configuration will be projected to a nearby local minimum rather than some uncorrelated configuration in the search space. Our analysis suggests that this implementation is less effective. The results below show the effect of three other implementations, which sample rigid-body transformations directly, rather than through active triangles, in a continuous neighborhood of the rigid-body transformation in the previous configuration in the minimization trajectory. These implementations use the same thresholds of δ ϕ = 10° and δ θ = 30°. What varies is the translation distance threshold t, which takes values in {1.5, 2.0, 2.5}Å. We decide to focus on varying t rather than the orientation, as the translation distance is expected to have a more dramatic effect on changing the contact interface. The goal of this analysis is to determine whether making small moves during minimization, which increases the probability of actually populating the minimum nearest to C perturb,i, has any effect on the distance between a perturbed configurations and its nearby minimum as well as on the overall quality of sampled local minima.

In summary, the analysis in [18] compares these implementations in terms of various statistics. First, the distance between C perturb,i to C i sampled by HopDock is recorded, referred to as i. The distribution of distances is tracked and compared across the various settings in terms of its median i m and the percentage of distances in the 0 - 5Ã… and 5 - 10Ã… range. The overall effect on the quality of the ensemble of configurations is also measured in terms of the lowest lRMSD to the native structure and the percentage of minima configurations with lRMSD < 5Ã… to the native structure. The analysis in [18] suggests that varying t in this range does not seem to result significant differences in the measured statistics. However, comparing the lowest lRMSD to the native structure and the overall number of minima within 5Ã… of the native structure shows that a translation distance t = 1.5Ã… provides a good compromise. For this reason, the rest of our experiments below use t = 1.5Ã….

Analysis of relationship between energy and proximity to native structure

Based on the above analysis, an ensemble of 10, 000 dimeric configurations is obtained for each of the 17 protein systems using HopDock with conserve th = 0.5, T e = T 0, d = 5Å, and t = 1.5Å. Here we investigate the extent to which an energetic reduction scheme that reduces the sampled ensemble Ω based on low energies is able to retain near-native configurations with low lRMSDs to the known native structure. For this purpose, we define a variable p to track the % of configurations with lowest energies retained in a reduced ensemble Ω p . p is varied from 10 - 100% increments of 10. Ω p = 100means that the entire ensemble Ω is retained. Ω p = 10means that only the 10% of the configurations with lowest energies are retained. Figure 5 plots the lowest lRMSD to the native structure over configurations in each reduced ensemble Ω p as p is varied. This is shown for each of the 17 protein systems. Figure 5 shows that the lowest lRMSD obtained by HopDock over the entire ensemble is retained even when p = 40 - 50% for most protein systems. This effectively means that near-native configurations are not discarded if focusing only on those with energies below the mean. For many systems, the lowest lRMSD does not change significantly even when only p is further reduced. This result is encouraging, particularly, if HopDock is considered as a configuration sampling technique to be employed in docking protocols. Even this coarse reduction by energy ensures that near-native configurations will be present in the reduced ensemble and can be further refined by docking protocols to improve their proximity to the native structure.

Figure 5
figure 5

Analysis of Lowest Energy Values. Lowest lRMSD from native structure is shown for each reduced Ω p ensemble on all 17 protein systems. Ω p contains the p% lowest-energy configurations generated by HopDock. Results for each protein system are shown in different colors.

Comparative analysis of HopDock to other existing methods

Table 3 shows the results obtained when applying HopDock (with the parameter values and implementations above) on the seventeen protein systems studied here. Columns 1-2 relate details on these dimers in terms of the PDB ID of the known native structure of the dimer and size (total number of atoms). Column 3 shows the lowest lRMSDs to the native structure as reported by Budda in [9], which uses geometric complementarity to match regions for docking and relies on clustering and some short energetic refinements of top clusters. Column 4 shows again for reference the lowest lRMSD obtained from our previous work which relies on exhaustive matching of active geometrically-complementary triangles [16]. Columns 5 and 6 show the lowest lRMSDs obtained on each dimer with the pyDock [4] and ClusPro [6] servers, respectively. The methods selected for the comparison are representative of geometry- and energy-based methods commonly used by docking protocols. Column 7 reports the lowest lRMSD obtained by the HopDock (the lowest-lRMSD configuration is shown superimposed on the native structure for 9 systems in Figure 6).

Table 3 Final Results of HopDock presented in this work.
Figure 6
figure 6

Analysis of Lowest lRMSD to Native Structures. Nine systems are selected to draw the lowest-lRMSD configuration obtained by HopDock. This configuration is drawn in opaque, with chains in blue and red. The native structure, over which the lowest-lRMSD configuration is superimposed to highlight structural differences, is drawn in transparent. The actual lRMSD between the two is shown below. Visualization is obtained through VMD [50].

Table 3 shows that HopDock obtains low lRMSDs to the native structure on each dimer. These lRMSDs are comparable to the geometric-based Budda method and our previous work in [16] on most protein systems. In few cases, our previous work, which relies on exhaustive sampling of geometrically-complementary active triangles, achieves slightly lower lowest lRMSDs than HopDock. This is largely due to the fact that a very large number of dimeric configurations, 100, 000 to 700, 000, depending on the size of the proteins are sampled in [16]. It is indeed encouraging to obtain similar lRMSDs, and even lower in some cases, with HopDock, which samples only about 10% of the configurations in [16]. The comparison of HopDock to two energy-based methods, pyDock and ClusPro, allows us to obtain a more comprehensive view of the results obtained by HopDock. In comparison to PyDock and ClusPro, the performance of HopDock in terms of proximity to the known native structure is better or comparable. This is particularly the case as the size of the protein system grows. This result is expected, as energy-based optimization methods operate on a large search space, whereas HopDock focuses on potentially-relevant contact interfaces through its combination of geometry and evolutionary conservation.

Comparative analysis of computing time and power

The above results are promising and suggest that HopDock is an important first step into a multi-stage docking protocol. Here we provide a broader picture by comparing HopDock to two established docking servers, pyDock [4] and ClusPro [6]. The purpose of this analysis is to better gage how HopDock compares to these servers, even though we are fully aware that the implementations in these servers are tuned and optimized, and that the methods in these servers use different search approaches and sophisticated energy functions. To get a sense of the resources available to HopDock as compared to these other serves, Table 4 summarizes number of processors, processing speed, memory, and average CPU time used by each method. Table 5 shows the time that each of these servers, including our own algorithm, HopDock, takes on each of the 17 systems studied here. This table shows that ClusPro is faster on most systems, but HopDock, though not fine tuned, achieves comparable running times to both servers. Taken together, these results suggest that HopDock is a promising search algorithm that ca be used in the first stage by docking protocols.

Table 4 Summary of the computing power of different docking protocols.
Table 5 Timing comparison.

Conclusion

We have presented here HopDock, a novel rigid-body protein docking algorithm based on the BH frame-work, to efficiently generate low-energy decoy configurations for dimeric systems. The algorithm conducts its search over the SE(3) space of rigid-body transformations but narrows its focus to regions corresponding to transformations aligning evolutionary conserved geometrically-complementary regions on molecular surfaces. The incorporation of evolutionary information reduces and simplifies the search space over which the structural perturbation in HopDock selects the dimeric configurations for minimization component. Since HopDock is a decoy sampling algorithm, a simple energy function has been employed to reduce the time complexity of the minimization component and measure the performance of HopDock. A detailed analysis of evolutionary conservation and different components of HopDock has been presented in this work. This analysis shows that HopDock produces many near-native configurations in the decoy ensemble it samples. A detailed comparative analysis shows that the algorithm is competitive with other state-of-the-art protocols. This suggests that HopDock is a promising decoy sampling algorithm to be incorporated in a docking protocols.

There are several further directions for future research. One involves taking into account additional criteria beyond evolutionary conservation to predict interaction interfaces [48, 49]. Pursuit of more sophisticated energy functions used by state-of-the-art docking protocols is another direction. We also intend to pursue different implementations, especially for the minimization component. While the perturbation component can focus on expediently obtaining configurations at a low-resolution level of detail (exploring the SE(3) space of rigid-body transformations), the minimization can add more detail to project a low-resolution configuration onto a nearby minimum of a more detailed energy surface. Combined with clustering and further refinement of top-populated clusters, the combination of a geometric and energetic treatment proposed here promises to result in an effective docking protocol. Wider sampling through population-based versions of the BH framework and incorporation of fluctuations on and nearby interaction interfaces will also be considered to improve the quality of decoy ensembles.

References

  1. Camacho CJ, Vajda S: Protein-protein association kinetics and protein docking. Curr Opinion Struct Biol 2002, 12: 36–40. 10.1016/S0959-440X(02)00286-5

    Article  CAS  Google Scholar 

  2. Dominguez C, Boelens R, Bonvin A: HADDOCK: A protein-protein docking approach based on biochemical or biophysical information. J Am Chem Soc 2003, 125: 1731–1737. 10.1021/ja026939x

    Article  CAS  PubMed  Google Scholar 

  3. Berman HM, Westbrook J, Feng Z, Gilliland G, Bhat TN, Weissig H, Shindyalov IN, Bourne PE: The Protein Data Bank. Nucleic Acids Research 2000, 28: 235–242. [http://www.pdb.org] 10.1093/nar/28.1.235

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  4. Cheng TMK, Blundell TL, Fernandez-Recio J: pyDock: Electrostatics and desolvation for effective scoring of rigid-body protein-protein docking. Proteins 2007,68(2):503–515. 10.1002/prot.21419

    Article  CAS  PubMed  Google Scholar 

  5. Chen R, Li L, Weng Z: ZDock: an initial-stage protein-docking algorithm. Proteins: Struct Funct Bioinf 2003, 52: 80–87. 10.1002/prot.10389

    Article  CAS  Google Scholar 

  6. Comeau SR, Gatchell DW, Vajda S, Camacho CJ: ClusPro: a fully automated algorithm for protein-protein docking. Nucl Acids Res 2004.,32(S1):

  7. Schneidman-Duhovny D, Inbar Y, Nussinov R, Wolfson HJ: PatchDock and SymmDock: servers for rigid and symmetric docking. Nucl Acids Res 2005,33(S2):W363-W367.

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  8. Inbar Y, Benyamini H, Nussinov R, Wolfson HJ: Combinatorial docking approach for structure prediction of large proteins and multi-molecular assemblies. J Phys Biol 2005, 2: S156-S165. 10.1088/1478-3975/2/4/S10

    Article  CAS  Google Scholar 

  9. Polak V: Budda: backbone unbound docking application. In Master's thesis. School of Computer Science, Tel-Aviv University, Tel-Aviv, Israel; 2003.

    Google Scholar 

  10. Lyskov S, Gray JJ: The RosettaDock server for local protein-protein docking. Nucl Acids Res 2008,36(S2):W233-W238.

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  11. Terashi G, Takeda-Shitaka M, Kanou K, Iwadate M, Takaya D, Umeyama H: The SKE-DOCK server and human teams based on a combined method of shape complementarity and free energy estimation. Proteins: Struct Funct Bioinf 2007,69(4):866–887. 10.1002/prot.21772

    Article  CAS  Google Scholar 

  12. Mashiach E, Nussinov R, Wolfson HJ: FiberDock: Flexible induced-fit backbone refinement in molecular docking. Proteins: Struct Funct Bioinf 2010,78(6):1503–1519.

    CAS  Google Scholar 

  13. Moitessier N, Englebienne P, Lee D, Lawandi J, Corbeil C: Towards the development of universal, fast and highly accurate docking/scoring methods: a long way to go. British J Pharmacology 2009,153(S1):S7-S27. 10.1038/sj.bjp.0707515

    Article  Google Scholar 

  14. Vajda S, Kozakov D: Convergence and combination of methods in protein-protein docking. Curr Opinion Struct Biol 2009,19(2):164–170. 10.1016/j.sbi.2009.02.008

    Article  CAS  Google Scholar 

  15. Hashmi I, Akbal-Delibas B, Haspel N, Shehu A: Protein Docking with Information on Evolutionary Conserved Interfaces. In Intl Conf on Biomed and Bioinf Workshops (BIBMW). IEEE; 2011:358–365.

    Google Scholar 

  16. Hashmi I, Akbal-Delibas B, Haspel N, Shehu A: Guiding Protein Docking with Geometric and Evolutionary Information. J Bioinf and Comp Biol 2012,10(3):1242002. 10.1142/S0219720012420024

    Article  Google Scholar 

  17. David J, Doye JP: Global Optimization by Basin-Hopping and the Lowest Energy Structures of Lennard-Jones Clusters Containing up to 110 Atoms. J Phys Chem A 1997,101(28):5111–5116. 10.1021/jp970984n

    Article  Google Scholar 

  18. Hashmi I, Shehu A: A Basin Hopping Algorithm for Protein-protein Docking. In Intl Conf on Bioinf and Biomed (BIBM). Edited by: Gao J, Dubitzky W, Wu C, Liebman M, Alhaij R, Ungar L, Christianson A, Hu X. IEEE; 2012:466–469.

    Google Scholar 

  19. Verma A, Schug A, Lee K, Wenzel W: Basin hopping simulations for all-atom protein folding. J Chem Phys 2006,124(4):044515. 10.1063/1.2138030

    Article  CAS  PubMed  Google Scholar 

  20. Prentiss MC, Wales DJ, Wolynes PG: Protein structure prediction using basin-hopping. The Journal of Chemical Physics 2008,128(22):225106–225106. 10.1063/1.2929833

    Article  PubMed Central  PubMed  Google Scholar 

  21. Olson B, Shehu A: Populating Local Minima in the Protein Conformational Space. IEEE Intl Conf on Bioinf and Biomed (BIBM) 2011, 114–117.

    Google Scholar 

  22. Olson B, Shehu A: Evolutionary-inspired probabilistic search for enhancing sampling of local minima in the protein energy surface. Proteome Sci 2012,10(Suppl 1):S5. 10.1186/1477-5956-10-S1-S5

    Article  PubMed Central  PubMed  Google Scholar 

  23. Olson B, Shehu A: Efficient basin hopping in the protein energy surface. In IEEE Intl Conf on Bioinf and Biomed (BIBM). Edited by: Gao J, Dubitzky W, Wu C, Liebman M, Alhaij R, Ungar L, Christianson A, Hu X, Philadelphia, PA. IEEE; 2012:119–124.

    Google Scholar 

  24. Olson B, Hashmi I, Molloy K, Shehu A: Basin Hopping as a General and Versatile Optimization Framework for the Characterization of Biological Macromolecules. Advances in AI J 2012.,2012(674832):

  25. Shehu A: Probabilistic Search and Optimization for Protein Energy Landscapes. In Handbook of Computational Molecular Biology. Edited by: Aluru S, Singh A. Chapman & Hall/CRC Computer & Information Science Series; 2013.

    Google Scholar 

  26. Metropolis N, Rosenbluth AW, Rosenbluth MN, Teller AH, Teller E: Equation of State Calculations by Fast Computing Machines. J Chem Phys 1953,21(6):1087–1092. 10.1063/1.1699114

    Article  CAS  Google Scholar 

  27. Akbal-Delibas B, Hashmi I, Shehu A, Haspel N: Refinement of Docked Protein Complex Structures Using Evolutionary Traces. In Intl Conf on Biomed and Bioinf Workshops (BIBMW). IEEE; 2011:400–404.

    Google Scholar 

  28. Akbal-Delibas B, Hashmi I, Shehu A, Haspel N: An Evolutionary Conservation Based Method for Refining and Reranking Protein Complex Structures. J of Bioinf and Comp Biol 2012,10(3):1242008. 10.1142/S0219720012420085

    Article  Google Scholar 

  29. Gabb HA, Jackson RM, Sternberg MJ, et al.: Modelling protein docking using shape complementarity, electrostatics and biochemical information. Journal of molecular biology 1997, 272: 106–120. 10.1006/jmbi.1997.1203

    Article  CAS  PubMed  Google Scholar 

  30. Mandell JG, Roberts VA, Pique ME, Kotlovyi V, Mitchell JC, Nelson E, Tsigelny I, Ten Eyck LF: Protein docking using continuum electrostatics and geometric fit. Protein Eng 2001,14(2):105–113. 10.1093/protein/14.2.105

    Article  CAS  PubMed  Google Scholar 

  31. Murphy J, Gatchell DW, Prasad JC, Vajda S: Combination of scoring functions improves discrimination in protein-protein docking. Proteins 2003,53(4):840–854. 10.1002/prot.10473

    Article  CAS  PubMed  Google Scholar 

  32. Venkatraman V, Yang YD, Sael L, Kihara D: Protein-protein docking using region-based 3D Zernike descriptors. BMC bioinformatics 2009, 10: 407+. 10.1186/1471-2105-10-407

    Article  PubMed Central  PubMed  Google Scholar 

  33. Connolly ML: Analytical Molecular Surface Calculation. J Appl Cryst 1983,16(5):548–558. 10.1107/S0021889883010985

    Article  CAS  Google Scholar 

  34. Lin SL, Nussinov R, Fischer D, Wolfson HJ: Molecular surface representations by sparse critical points. Proteins 1994, 18: 94–101. 10.1002/prot.340180111

    Article  CAS  PubMed  Google Scholar 

  35. Wolfson HJ, Rigoutsos I: Geometric hashing: an overview. IEEE Comp Sci and Engineering 1997,4(4):10–21. 10.1109/99.641604

    Article  Google Scholar 

  36. Esquivel-Rodríguez J, Yang YD, Kihara D: Multi-LZerD: Multiple protein docking for asymmetric complexes. Proteins 2012.

    Google Scholar 

  37. Chen BY, Honig B: VASP: a volumetric analysis of surface properties yields insights into proteinligand binding specificity. PLoS Comput Biol 2010.,6(8):

  38. Fischer D, Lin SL, Wolfson HL, Nussinov R: A geometry-based suite of molecular docking processes. J Mol Biol 2005,248(2):459–477.

    Google Scholar 

  39. Lichtarge O, Bourne HR, Cohen FE, et al.: An Evolutionary Trace Method Defines Binding Surfaces Common to Protein Families. J Mol Biol 1996,257(2):342–58. 10.1006/jmbi.1996.0167

    Article  CAS  PubMed  Google Scholar 

  40. Engelen S, Trojan LA, Sacquin-Mora S, Lavery R, Carbone A: A Large-Scale Method to Predict Protein Interfaces Based on Sequence Sampling. PLoS Comp Bio 2009, 5: e1000267. 10.1371/journal.pcbi.1000267

    Article  Google Scholar 

  41. Goldenberg O, Erez E, Nimrod G, Ben-Tal N: The ConSurf-DB: pre-calculated evolutionary conservation profiles of protein structures. Nucleic Acids Research 2009, 37: D323-D327. 10.1093/nar/gkn822

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  42. Brooks BR, Bruccoleri RE, Olafson BD, Swaminathan S, Karplus M, et al.: CHARMM: A program for macromolecular energy, minimization, and dynamics calculations. J Comput Chem 1983,4(2):187–217. 10.1002/jcc.540040211

    Article  CAS  Google Scholar 

  43. Kortemme T, Baker D: A simple physical model for binding energy hot spots in protein-protein complexes. Proc Natl Acad of Sci USA 2002,99(22):14116–14121. 10.1073/pnas.202485799

    Article  CAS  Google Scholar 

  44. Louren¸co H, Martin O, Stützle T: Iterated Local Search. In Handbook of Metaheuristics, Volume 57 of Operations Research & Management Science. Edited by: Glover F, Kochenberger G. Kluwer Academic Publishers; 2002:321–353.

    Google Scholar 

  45. Kanamori E, Murakami Y, Tsuchiya Y, Standley DM, Nakamura H, Kinoshita K: Docking of protein molecular surfaces with evolutionary trace analysis. Proteins: Struct Funct Bioinf 2007, 69: 832–838. 10.1002/prot.21737

    Article  CAS  Google Scholar 

  46. Choi YS, Yang JS, Choi Y, Ryu SH, Kim S: Evolutionary conservation in multiple faces of protein interaction. Proteins 2009, 77: 14–25. 10.1002/prot.22410

    Article  CAS  PubMed  Google Scholar 

  47. Matthews BW, et al.: Comparison of the predicted and observed secondary structure of T4 phage lysozyme. Biochimica et Biophysica Acta (BBA) - Protein Structure 1975, 405: 442–451. 10.1016/0005-2795(75)90109-9

    Article  CAS  Google Scholar 

  48. Glaser F, Steinberg DM, Vakser IA, Ben-Tal N: Residue frequencies and pairing preferences at protein-protein interfaces. Proteins 2001,43(2):89–102. 10.1002/1097-0134(20010501)43:2<89::AID-PROT1021>3.0.CO;2-H

    Article  CAS  PubMed  Google Scholar 

  49. Chen CT, Peng HP, Jian JW, Tsai KC, Chang JY, Yang EW, Chen JB, Ho SY, Hsu WL, Yang AS: Protein-Protein Interaction Site Predictions with Three-Dimensional Probability Distributions of Interacting Atoms on Protein Surfaces. PLoS ONE 2012,7(6):e37706+. 10.1371/journal.pone.0037706

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  50. Humphrey W, Dalke A, Schulten K, et al.: VMD - Visual Molecular Dynamics. Journal of Molecular Graphics 1996, 14: 33–38. 10.1016/0263-7855(96)00018-5

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

This work is supported in part by NSF IIS CAREER Award No. 1144106. The authors would like to thank members of the Shehu lab for their valuable comments on this work.

Declarations

The publication costs for this article were funded by the corresponding author AS through NSF Grant No. 1144106.

This article has been published as part of Proteome Science Volume 11 Supplement 1, 2013: Selected articles from the IEEE International Conference on Bioinformatics and Biomedicine 2012: Proteome Science. The full contents of the supplement are available online at http://www.proteomesci.com/supplements/11/S1.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Amarda Shehu.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

IH suggested the methods and the performance study in this manuscript and drafted the manuscript. AS guided the study, provided comments and suggestions on the methods and performance evaluation, and improved the manuscript writing.

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/2.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Cite this article

Hashmi, I., Shehu, A. HopDock: a probabilistic search algorithm for decoy sampling in protein-protein docking. Proteome Sci 11 (Suppl 1), S6 (2013). https://doi.org/10.1186/1477-5956-11-S1-S6

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1477-5956-11-S1-S6

Keywords