Next Article in Journal
Poly[(3-hexylthiophene)-block-(3-semifluoroalkylthiophene)] for Polymer Solar Cells
Next Article in Special Issue
Molecular Interactions and Protein-Induced DNA Hairpin in the Transcriptional Control of Bacteriophage Ø29 DNA
Previous Article in Journal / Special Issue
Computational Prediction of O-linked Glycosylation Sites that Preferentially Map on Intrinsically Disordered Regions of Extracellular Proteins
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Binding Ligand Prediction for Proteins Using Partial Matching of Local Surface Patches

1
Department of Computer Science, Purdue University, West Lafayette, IN 47907, USA
2
Department of Biological Sciences, Purdue University, West Lafayette, IN 47907, USA
3
Markey Center for Structural Biology, Purdue University, West Lafayette, IN 47907, USA
*
Author to whom correspondence should be addressed.
Int. J. Mol. Sci. 2010, 11(12), 5009-5026; https://doi.org/10.3390/ijms11125009
Submission received: 2 November 2010 / Revised: 2 December 2010 / Accepted: 3 December 2010 / Published: 6 December 2010
(This article belongs to the Special Issue Advances in Molecular Recognition)

Abstract

:
Functional elucidation of uncharacterized protein structures is an important task in bioinformatics. We report our new approach for structure-based function prediction which captures local surface features of ligand binding pockets. Function of proteins, specifically, binding ligands of proteins, can be predicted by finding similar local surface regions of known proteins. To enable partial comparison of binding sites in proteins, a weighted bipartite matching algorithm is used to match pairs of surface patches. The surface patches are encoded with the 3D Zernike descriptors. Unlike the existing methods which compare global characteristics of the protein fold or the global pocket shape, the local surface patch method can find functional similarity between non-homologous proteins and binding pockets for flexible ligand molecules. The proposed method improves prediction results over global pocket shape-based method which was previously developed by our group.

1. Introduction

Functional elucidation of uncharacterized protein structures is an important task in bioinformatics [14]. Computational function prediction methods typically search for similar sequential/structural patterns taken from the protein of unknown function in known proteins. Recently, functional characterization of proteins from their tertiary structures is becoming more important as an increasing number of protein structures of unknown function are being solved. As of October 2010, there are 3221 out of 68421 structures of unknown function in the Protein Data Bank (PDB) [5], most of which were solved by Structural Genomics projects [6]. They do not have homologous proteins of known function as they do not have even electronic annotations. This necessitates the development of computational approaches that enables the prediction of protein functions even in the absence of obvious homologous protein. Using structural information is a promising way for non-homology based function prediction.
There are two approaches for utilizing the tertiary structure information in the function prediction: to consider global fold of proteins or to capture common local structures of proteins. Methods that compare the global fold similarities, such as FINDSITE [7], are based on the observation that the evolutionary relationships of proteins can be better tracked by overall fold similarity than by sequence similarity [810]. However, since there are proteins of different function that adopt the same fold, such as the TIM-barrel fold, caution is needed in inferring function from the global structure [11]. On the other hand, methods that consider the local structures aim to capture local geometry of known functional sites. As local methods directly search for geometrical and physicochemical properties of functional sites, the local approaches could identify functional similarity between proteins that lack both sequence similarity and structural similarity [1214].
A typical local structure based function prediction approach can be divided into two logical parts: (1) prediction of characteristic local sites, usually pockets, in a given protein, and (2) comparison of the identified local sites against a database of known functional sites to make prediction of function of the protein. There are several methods available for the first part, i.e., ligand binding site predictions. Existing methods that use the shapes of protein structures include SURFNET [15], POCKET [16], PHECOM [17], PocketPicker [18], VisGrid [19], PocketDepth [20], and CAST [21]. In many cases, a small ligand molecule binds to a surface pocket of a protein. Thus, most binding site prediction methods take the strategy of identifying the pockets regions of the protein. There are also several methods that consider additional information, such as sequence conservation [22,23] and physical potentials [2426].
There are also many algorithms for the second step, i.e., comparison of ligand binding sites. Comparison methods are intertwined with how ligand binding sites are represented [27]. In the Catalytic Site Atlas [28], AFT [29], and SURFACE [30], where a local site is represented as a set of few residue positions, the root mean square deviation (RMSD) of equivalent amino acid residues is computed. In SiteBase [31], atoms in ligand binding sites are compared using geometric hashing. Another functional local site database, eF-Seek [32], represents a protein surface as a graph with nodes characterized by local geometry and electrostatic potentials, and hence uses a maximum subgraph algorithm for seeking similar sites. Thornton and her colleagues explored the use of spherical harmonics in representing and comparing protein pockets [14,33]. A more recent method introduced by Hoffmann and colleagues [34] applies a convolution kernel method on surface atom positions and charges at ligand binding sites.
In our previous work, we have developed a pose independent binding pocket comparison method, named Pocket-Surfer, which computes the similarity of the global surface shape and the electrostatic potential of pockets [13]. The method uses the 3D Zernike descriptor (3DZD), a mathematical series expansion of a three dimensional function [35], for representing the global pocket properties in a rotational invariant fashion. The benchmark study showed competitive, if not superior, performance of Pocket-Surfer as compared to other existing methods [13]. However, we have noticed that pockets of some ligand molecules have diverged shapes, which poses a significant challenge for a global pocket descriptors like Pocket-Surfer. For such pockets with diverged shape, some local regions show consistent property across different proteins while there are other regions which show more diversity. Thus, it would be beneficial to be able to compare local regions within the binding site separately and consider only regions that have high similarities.
Following this idea, this paper proposes a local surface patch method that analyzes the similarities between binding pockets by segmenting pocket region to smaller surface patches and comparing the pockets based on the shape of the patches. In the comparison process, the patches from two pockets are partially matched by a modified bipartite algorithm, which selectively evaluates only the patch pairs that have similar shapes. Shapes of local surface patches are encoded by the 3DZD. The new method showed a better performance over the previous Pocket-Surfer, which considers global geometric aspects of binding pockets.

2. Materials and Methods

2.1. Overview of the Algorithm

Given a protein structure, the first step of the local surface patch method is to generate surface of the protein, from which a binding pocket is extracted. The pocket is further segmented to surface patches where each patch is encoded by the 3DZD for efficient storage and comparison. Next, the query pocket is compared to the other pockets stored in the database. The pocket comparison process composes of partial matching that utilizes a modified bipartite matching algorithm to pair similar patches from the two compared pockets. The top n best matching pairs are selected and used to score and predict the binding ligand of the query pocket. The flow of the algorithm is shown in Figure 1. Each step is described in detail in the following sections.

2.2. Local Surface Patch Extraction

A pocket is characterized by a set of surface patches whose shape is encoded by the 3DZD. Figure 2 illustrates the process. A protein surface is computed as the boundaries of solvent accessible and solvent excluded regions generated by the Adaptive Poisson-Boltzmann Solver (APBS) program [36]. After the surface of the whole protein is computed, a pocket is extracted by casting rays from the center of the ligand binding pocket (Figure 2, left). Rays are cast from the predetermined pocket centers and surface positions that are encountered first by the rays are selected as the pocket surface. The extraction process requires the position of the known or predicted ligand position, which is used to compute the pocket centers. In this work, the binding site location in a protein is obtained from the center positions of the binding ligand to the protein. Then, selected surface points that are disconnected from the largest region are removed and holes in the pocket surface are filled if there are any.
Once a pocket region is defined in a protein surface, local surface patches are extracted from the pocket region. A local surface patch is a single surface region (i.e., not disconnected to two or more pieces) that is within a specified distance (5 Å is used) from the selected center called a “seed” (Figure 2, middle). Seed points are selected by taking surface points that are closer than 1.5 Å to any surface atom but should not be closer than 3 Å from the other points which are already selected. Surface atoms are defined as atoms that are within 3.5 Å to the surface of the proteins. The number of seed points for each ligand binding pocket type is shown in Table 1. The average numbers of seed points has a significant correlation of 0.994 to the molecular mass of the ligands.
The geometrical shape of surface patches is encoded by the 3DZD (Figure 2, right). To compute the 3DZD for a surface patch, the surface patch is placed on a 3D grid and a grid point is assigned 1 if it is on the surface patch and 0 otherwise. This is considered as the 3D function, which is expanded as a series function to form the 3DZD (see the next section). The local 3D Zernike descriptor (lzd) of the ith seed of a pocket P, lzdpi, is composed of a seed coordinate, sPi = (xPi,yPi,zPi), and a 3DZD, zd Pi,. The local surface patch descriptor of pocket P, lspdP, is list of lzds for each of the seeds in the pocket: lspdP = [lzdp0, lzdp1, …, lzdpn], where n is the number of seeds in pocket P.

2.3. Encoding Local Surface Patch Using the 3D Zernike Descriptor

The 3DZD gives a series expansion of a 3D function, allowing compact and rotationally invariant representation of a 3D object (i.e., a 3D function). Mathematical foundation of the 3DZD was laid by Canterakis [35]. Later Novotni and Klein [37] have applied it to 3D shape retrieval. Below we provide a brief mathematical derivation of the 3DZD. See the two papers for more details [35,37]. Our group has applied the 3DZD successfully to various protein and ligand structure analyses [27,38,39], including rapid protein global shape analysis ( http://kiharalab.org/3d-surfer) [40,41], quantitative comparison for protein surface physicochemical property [42], small ligand molecule comparison [43], protein-protein docking prediction [44], and comparison of low-resolution electron density maps [45].
To represent a surface shape, each grid cell (voxel) is assigned 1 if it is on the surface and 0 otherwise. The resulting 3D grid is considered as an input 3D function, f(x), which is expanded into a series in terms of Zernike-Canterakis basis [35] defined as follows:
Z nl m ( r , ϑ , ϕ ) = R nl ( r ) Y l m ( ϑ , ϕ )
where −l < m < l, 0 ≤ ln, and (nl) even. Y l m ( ϑ , ϕ ), are the spherical harmonics and Rnl (r) are radial functions defined by Canterakis constructed so that Z nl m ( r , ϑ , ϕ ) can be converted to polynomials, Z nl m ( x ), in the Cartesian coordinates. Now 3D Zernike moments of f (x) are defined by the expansion in this orthonormal basis, i.e., by the formula
Ω nl m = 3 4 π | x | 1 f ( x ) Z ¯ nl m ( x ) d x
The rotational invariance is obtained by defining the 3DZD series, Fnl, as norms of vectors Ωnl.
F nl = m = l m = l ( Ω nl m ) 2
The parameter n is called the order of 3DZD and it determines the resolution of the descriptor. As stated above, n defines the range of l and a 3DZD is a series of invariants (Equation 3) for each pair of n and l, where n ranges from 0 to the specified order. We use order n = 15 in the local surface patch comparison.
Finally, the obtained 3DZD is normalized to a unit vector by dividing each moment by the norm of the whole descriptor. This normalization is found to reduce dependency of 3DZD on the number of voxels used to represent a protein [42].

2.4. Comparing Surface Patches of Pockets Using Partial Matching Algorithm

Comparing a query pocket A to a database pocket B is performed in two steps. The first step is to measure the distance (dissimilarity) between pairs of surface patches in two pockets. The distance of a surface patch pair, lzdAi, and lzdBj, i.e., the ith patch in pocket A and the jth patch in pocket B, is defined as the Euclidian distance between the two 3DZD vectors. In the second step, surface patches of the two pockets are matched according to the distance so that the total distance of the matched pairs is minimized. This is similar to the weighted bipartite matching problem, which can be approximately solved by the auction algorithm [46]. The original auction algorithm is designed to obtain the maximum total weights for a complete bipartite matching, where each item in one group is matched with an item in another group without overlap. We modified the original auction algorithm in two ways for the pocket comparison: First, a distance threshold value is introduced for pairing two surface patches so that dissimilar patches are not matched. Thus, rather than matching all the patches in a query pocket to patches in another pocket, only similar ones are selectively paired to enable partial matching of two pockets (i.e., partial bipartite matching, rather than complete bipartite matching). Also, since we want to obtain pairs of patches that minimize total distance while the original auction algorithm maximizes the total weight values of pairs, we defined the weight for a pair of patches as (Constant-value – the Euclidean distance of the 3DZD vectors). The pseudo code of the modified bipartite matching is provided in Figure 3.
The algorithm works as follows: First all patches in pocket B is stored in the queue Q. The queue Q becomes empty when each patch in pocket B either finds a satisfying pair in pocket A or is found to have no sufficiently similar patches (closer than the threshold distance, td) in A. No more than one patch in B is assigned to a patch in A. For a query patch lzdBi, when it finds a sufficiently similar patch, lzdAi, the previous patch in B that paired with lzdAj is put back to the Q and the new patch in B, lzdBi is now assigned to lzdAj. The patch in B which is put back to Q has another round to be evaluated to find a similar patch in A. When patches are competed for a same lzdAi, the p value for lzdAi is increased, so that at the end a patch in B that is most similar to lzdAi will be selected for its pair. This is the intention of raising the minimum bid value, pj, at each iteration. The iteration is only continued till 10 * nA times. Usually the iteration stops before the interaction threshold. In the end, the algorithm output the pairs of patches from A and B that are similar to each other than the threshold value, td.

2.5. Scoring Pocket Distance and Binding Ligand Types

After patches in A and B are paired, the score (distance) of pocket A and B is computed using three scoring terms: the distance of the patch pairs, the difference of relative position of the matched patches in A and B, and the difference of pocket size of A and B. The first scoring term computes the weighted average distance of the 3DZD values of paired patches. For a query pocket A and a pocket B in the database, avgZd is defined as follows:
avgZd ( A , B , m A , B ) = ( n A N ) ( 1 N i m A , B d s l z d ( lzd m i A A , lzd m i B B ) )
where mA,B contains N pairs of patches paired between pocket A and B, i.e., it contains indices of matched pairs (mAi, mBi). nA is the number of patches in pocket A (Table 1), dslzd is the Euclidian distance between the 3DZD of a pair of matched patches, lzd m i A A and lzd m i B B. n A N is a weighting factor that penalizes the match mA,B when the number of matched pairs N is smaller than the number of patches in the query pocket, A. Since avgZd is the distance, a smaller value means that the two pockets are more similar to each other.
The second scoring term considers relative position of matched patches in pocket A and pocket B. The relative position difference score (rpd) for a set of matched pairs, mA,B, is defined as follows:
rpd ( A , B , m A , B ) = ( n A N ) ( 2 N ( N 1 ) i = 0 N 1 j = i + 1 N | l 2 ( s m i A A , s m j A A ) l 2 ( s m i B B , s m j B B ) | )
where s m i A A is the coordinates of the seed points of the i-th patch of proteins A in mA,B and l2 denotes the Euclidean distance (the l2 norm) of the two patches in the parenthesis.
The last term, which considers the pocket size difference, has been found to increase comparison performances in the previous study [13,14]. It is defined as follows:
pocketSd ( A , B ) = | n A n B n B |
Thus, it is the difference of the number of patches between the pocket A and B.
The three scoring terms are weighted and combined to obtain the final score of pocket A and B:
Totalscore ( A , B ) = w 1 × avgZd ( A , B , m A , B ) + w 2 × rpd ( A , B , m A , B ) + ( 1 w 1 w 2 ) × pocketSd ( A , B )
where the weights are 0 ≤ w1 ≤ 1 and 0 ≤ w2 ≤ 1. The weight values w1 = 0.06 and w2 = 0.14 are used in this study.
Using Equation 7, pockets in the database are sorted in the ascending order to the query pocket A (the smaller, the closer to the query). Given the rank of the pockets, the binding ligand for the query pocket is finally predicted using the Pocket_score, which was used in our previous work [13]. The score for ligand type F for a query pocket P is defined as
Pocket _ score ( P , F ) = i = 1 k ( δ l ( i ) , F log ( n i ) ) · i = 1 k δ l ( i ) , F i = 1 n δ l ( i ) , F
where l(i) denotes the ligand type (ATP, FMN, etc.) of the i-th closest pocket to the query, n is the number of pockets of the type F in the database, and the function δl(i),F equals to 1 if i-th protein is of type F, and is 0 otherwise. The first term is to consider top k closest pockets to the query, with a higher score assigned to a pocket with a higher rank. We used 18 for k in this work. The second term is to normalize the score by the number of pockets of the same type F included in the database. The ligand with the highest Pocket_score is predicted to bind to the query pocket.

2.6. Dataset

The benchmark dataset consists of 100 proteins selected by Kahraman et al. [14]. This dataset was previously used to benchmark a pocket comparison method which uses spherical harmonics by Kahraman et al. [14]. In our previous work, we also used this dataset to benchmark the Pocket-Surfer method [13]. Each of the 100 proteins binds to one of the following nine ligands: adenosine monophosphate (AMP), adenosine-5′-triphosphate (ATP), flavin adenine dinucleotide (FAD), flavin mononucleotide (FMN), alpha- or beta-d-glucose (GLC), heme (HEM), nicotinamide adenine dinucleotide (NAD), phosphate (PO4), or 3-beta-hydroxy-5-androsten-17-one (AND) and estradiol (EST), which are two types of steroids (STR). Proteins were selected from different homologous families in the CATH database (i.e., H-level in CATH) so that they are not homologous to each other. Their tertiary structures were solved by X-ray crystallography.

2.7. Performance Evaluation

Prediction performance is evaluated by the fraction of successful predictions where the correct ligand for the query pocket is predicted within top 1 or top 3 scores. These are called the Top-1 and Top-3 success rate. In addition, we also use the area under curve (AUC) of the receiver operating characteristic (ROC) curve. To obtain ROC curves, each query pocket is compared with all other pockets in the dataset and the top k pockets in the database are retrieved. Then, they are evaluated by computing the false positive (x-axis) and the true positive (y-axis) rate. The value of k is varied from 1 to N-1 where N is the number of proteins in the dataset. The false positive rate is defined as the ratio of the number of retrieved pockets of a different ligand (i.e., false positives) relative to the total number of pockets of a different ligand (i.e., false positives and true negatives) in the dataset. The true positive rate is the ratio of the number of correctly retrieved pockets (i.e., true positives) relative to the total number of pockets of the same type in the dataset. The false positive rate equals true positive rate, on average, in random retrieval (an AUC value of 0.5).

3. Results

3.1. Effect of the Threshold Value for Patch Similarity

The prediction performance of the proposed method is evaluated on the dataset of 100 proteins. First, we examine the effect of the threshold value, td (Figure 3) to the performance, which controls the minimum similarity to pair patches. A larger threshold value allows more patch pairs to form whose pairwise distance satisfies dij < td.
Figure 4 shows the AUC values and the Top-3 success rate for different distance threshold values. To make individual curves more visible, the ligand types are arbitrarily divided into two groups that show similar trends: The first group contains pockets that bind to ATP, FAD, FMN, NAD, and STR (Figure 4A,D) while the another group includes pockets that bind to AMP, GLC, HEM, and PO4 (Figure 4B,E). In terms of the AUC value, ligand types in the first group (Figure 4A) tend to have higher values at the distance threshold between 0.15 and 0.25. On the other hand, the AUC values of the second group (Figure 4B) become higher as larger distance threshold values are used. This observation is consistent for the results with the Top-3 success rate (Figure 4D,E). Averaging the results of all the ligand types, the AUC values sharply increases until the threshold value of 0.2 and gradually increases as the threshold value is increased until the infinite distance was used (i.e., no threshold value used, NT) (Figure 4C). The average Top-3 success rate shows a similar trend, the value increases sharply until the threshold value of 0.2 and becomes stable after that point (Figure 4F). The largest Top-3 success rate is observed at the distance threshold of 0.30, which is 0.859.
Figure 5 shows the number of pairs of patches matched for different threshold values used. The value is averaged over the all ligand types. Only very similar patches from two pockets are matched when a small (i.e., strict) distance threshold value is used, and the number of matched pairs increases as more permissive (i.e., larger) distance value is used. At the distance threshold value of 0.2 where high AUC value and Top-3 success rate are shown in the previous figure (Figure 4), 19.94 pairs are matched for pockets of the same ligand type while 17.12 pairs are matched on average between pockets of different ligand type. The average number of matched pairs reaches plateau after the threshold value of 0.30 and it finally reaches to 24.7 pairs (different ligand types: 20.1 pairs) when no threshold is used. The reason of the plateau is simply because the number of matched pairs reaches to the total number of patches in a pocket (Table 1).
Considering the overall ligand prediction accuracy shown in Figure 4C,F, results of the distance threshold value of 0.30 is shown for the subsequent results. It is also interesting to note that 0.30 is close to the average distance between correct pairs of patches in pockets of the same ligand, which is 0.305.

3.2. Prediction Performance

This section presents overall prediction performance of the proposed method. In Table 2, the average AUC value of the current method, termed Patch 3DZD here, is compared with previously proposed similar pocket shape descriptors. All of the four previously proposed methods are based on series expansion of 2D or 3D function. The first two methods, which use the 2D Pseudo-Zernike moments and the 2D Zernike moments, were proposed by our group [13]. For these methods, the surface of a pocket is projected to a 2D map from the center of the pocket, which is then represented by the 2D Pseudo-Zernike or 2D Zernike moments. The use of the spherical harmonics was proposed by Kahraman et al. [14]. The next one, the global 3DZD based method, represents a whole pocket shape by the 3DZD. This approach was also proposed by our group in the previous work [13]. In contrast to the global 3DZD method, the current method describes a pocket shape by a combination of local patches using the 3DZD as explained in Methods. Using each pocket descriptor, either the pocket shape information only or combination of the pocket shape and size information is encoded. For the 2D Pseudo-Zernike, 2D Zernike, and the global 3DZD, the pocket size information is weighted and added as an additional element of a vector of expansion coefficients of the descriptors. For the spherical harmonics, the size information is reflected in the zero-th order coefficient. Thus, dividing all coefficients by the zero-th order removes the influence of the size information. For more technical details, refer to the original papers [13,14]. For the current patch 3DZD method, weighted sum of avgZd and rpd terms (Equations 4 and 5) is used for the shape information with the weighting factor of w1 = 0.06 and w2 = 0.14. Equation 7 is used for the combination of the pocket shape and size information.
First of all, all the results in Table 2 are better than random (which yields an AUC value of 0.5). It is also shown that adding pocket size information always improves the AUC value for 12–15%. Among the descriptors, the local surface patch method, pPatch 3DZD, performs the best with the largest AUC value of 0.76 with shape information and 0.82 with pocket shape and size information. Compared to the global 3DZD, using local surface patches is very effective in capturing pocket shapes of same binding ligands as evidenced by the significant improvement of the AUC value from 0.66 to 0.76.
Next, Table 3 shows the breakdown of the performance of the patch 3DZD for individual ligand types. Results of the three descriptors are shown: Descriptors encoding the pocket shape information, those encoding shape and the size information, and ones encoding only the size information. In addition, results of random retrieval are shown for control.
On average, both shape and shape + size are better than random in the Top-1 and Top-3 success rate. Overall, the best performance in terms of both AUC (0.82) and prediction accuracy (Top-1 rate of 0.45 and Top-3 rate of 0.86) is obtained using shape+size information. Pockets that bind to ATP, FAD, HEM, and PO4 are easy targets where the pocket size information alone yields over 0.75 for Top-3 success rate. For the easy targets, shape information alone also results in high prediction accuracy of 0.90 in Top-3 or higher. For harder targets, pockets that bind to FMN, GLC, and STR, pocket size information is not able to correctly predict ligand types within top 3 predictions. For these cases, shape information is able to provide prediction with good accuracy except for FMN. Also, shape + size improves the accuracy for FMN and GLC. To conclude, shape information and size information supplement each other and in general, shape alone can provide good predictions independent from the size information.

3.3. Examples of Matched Local Surface Patches

Figure 6 shows an example of matched local surface patches using different distance thresholds for two NAD binding proteins, PDBID: 1qax and PDBID: 2a5f. The left panel shows the global shape of the pockets. The pocket of 1qax contains 38 overlapping surface patches and the pocket of 2a5f contains 36. Since visualizing maximum of 36 surface patch pairs will complicate the figure, only selected pairs are shown. Using the distance threshold value of 0.1, four patch pairs are matched, among which three pairs locate at equivalent positions in the ligand binding pockets. Both magenta patches are near adenosine of NAD and both yellow and blue patch pairs are near the nicotinamide ribose region. In addition to these pairs, more pairs are found at equivalent positions using the threshold value of 0.15. In the figure, two pairs of such correctly matched patches are shown as examples. However, using more permissive distance threshold values increases incorrect matches. This observation agrees with the highest prediction accuracy for NAD observed at the threshold value of 0.15 in Figure 3. Two pairs of such incorrect matches are shown in the rightmost panel of Figure 6. In general, increasing the distance threshold value allows more correct patch pairs to be formed, however, incorrect matches can also occur to result in reduction of the overall match score.
The surface patch method also identifies local similarities of different ligand binding pockets. One such example is adenosine monophosphate (adenine + ribose + phosphate) group shared by AMP, ATP, NAD, and FAD. Figure 7 shows matched patch pairs between four pockets, each of which binding AMP, ATP, NAD, and FAD. Patches of the same color locate at equivalent positions relative to adenosine monophosphate. The blue patches in the four pockets are all located at the phosphate binding region, the magenta patches are at the ribose region and the yellow patches are all located at the adenine region of the bound ligand. Local surface matches in different types of pockets can deteriorate the binding ligand prediction in the current benchmark test. Indeed, when ATP binding pockets are queried against the benchmark dataset, AMP comes within Top-3 prediction in six out of nine cases, and five out of fourteen cases of searches from AMP binding pockets retrieve ATP within Top-3. Similarly, when FAD binding pockets are queried, NAD shows up within Top-3 for all of the ten cases, while seven out of fifteen cases FAD is within Top-3 prediction when NAD binding pockets are queried. The method does not confuse between ATP/AMP and FAD/NAD since their pocket sizes are largely different (Table 1).
On the other hand, this is an interesting and encouraging data which shows that the method is able to recognize same chemical group binding sites in protein pockets because this can lead to future method development for more general local surface characterization and classification.

3.4. Computation Time

On a Linux computer with Intel core i7 at 2.67 GHz and 11GB memory, binding ligand prediction for a query protein takes on average about two and half minutes with the patch 3DZD method (Table 4). This is about five times longer than the global 3DZD method (3D-Surfer). The preparation process comprises ligand binding site prediction, protein surface property computation, and computation of the local surface patch descriptors. The patch 3DZD method takes more time for the preparation step as compared with the global 3DZD method because the 3DZD needs to be computed for each patch in a pocket.

4. Discussion

We have presented a new binding ligand prediction method which is based on local surface patch-based pocket shape comparison. Generally speaking, intrinsic conformational change of proteins is a challenge to handle for protein shape-based function prediction methods. The current method accommodates the variance of the shape of pockets that bind to the same ligand molecule by capturing the local similarity of pockets. The similarity of two pockets is quantified for a set of similar surface patch pairs. Thus, the score of two pockets reflect only similar regions between them, while discarding variable regions. We were able to gain better performance with the patch-based method than our previous work which uses global pocket comparison method, Pocket-Surfer [13].
In this work, we have only used shape information to characterize a surface patch. However, shape is not the only molecular recognition factor in protein-ligand interaction. Thus, it would be interesting to considering other properties that are important in recognizing ligand molecules such as physicochemical properties of the protein surfaces. 3DZD can also be used to encode and compare the physicochemical properties of surface patches, as we have shown in the previous works [13,42,47].
To conclude we have shown that the local surface patch method is powerful in comparing local regions of proteins surface. With the proposed methods, we are now able to compare local regions of the protein surface effectively. This method has many possible applications such as comparing complementary regions of protein-protein docking interface and annotating protein surfaces for more general function prediction to local surface regions.

Acknowledgments

This work was supported by the National Institute of General Medical Sciences of the National Institutes of Health (R01 GM075004). DK also acknowledges funding from the National Science Foundation (DMS800568, IIS0915801, EF0850009).

References

  1. Hawkins, T; Kihara, D. Function prediction of uncharacterized proteins. J. Bioinf. Comput. Biol 2007, 5, 1–30. [Google Scholar]
  2. Hawkins, T; Chitale, M; Kihara, D. New paradigm in protein function prediction for large scale omics analysis. Mol. BioSyst 2008, 4, 223–231. [Google Scholar]
  3. Watson, JD; Laskowski, RA; Thornton, JM. Predicting protein function from sequence and structural data. Curr. Opin. Struct. Biol 2005, 15, 275–284. [Google Scholar]
  4. Valencia, A. Automatic annotation of protein function. Curr. Opin. Struct. Biol 2005, 15, 267–74. [Google Scholar]
  5. Berman, HM; Westbrook, J; Feng, Z; Gilliland, G; Bhat, TN; Weissig, H; Shindyalov, IN; Bourne, PE. The protein data bank. Nucleic Acids Res 2000, 28, 235–242. [Google Scholar]
  6. Chandonia, J; Brenner, SE. The impact of structural genomics: Expectations and outcomes. Science 2006, 311, 347–351. [Google Scholar]
  7. Skolnick, J; Brylinski, M. FINDSITE: A combined evolution/structure-based approach to protein function prediction. Brief. Bioinform 2009, 10, 378. [Google Scholar]
  8. Kihara, D; Skolnick, J. Microbial genomes have over 72% structure assignment by the threading algorithm PROSPECTOR_Q. Proteins: Struct. Funct. Bioinf 2004, 55, 464–473. [Google Scholar]
  9. Pal, D; Eisenberg, D. Inference of protein function from protein structure. Structure 2005, 13, 121–130. [Google Scholar]
  10. Orengo, CA; Thornton, JM. Protein families and their evolution—A structural perspective. Biochemistry 2005, 74, 867–900. [Google Scholar]
  11. Orengo, CA; Jones, DT; Thornton, JM. Protein superfamilies and domain superfolds. Nature 1994, 372, 631–634. [Google Scholar]
  12. Ausiello, G; Peluso, D; Via, A; Helmer-Citterish, M. Local comparison of protein structures highlights cases of convergent evolution in analogous functional sites. BMC Bioinformatics 2007, 8, S24. [Google Scholar]
  13. Chikhi, R; Sael, L; Kihara, D. Real-time ligand binding pocket database search using local surface descriptors. Proteins: Struct. Funct. Bioinf 2010, 78, 2007–2028. [Google Scholar]
  14. Kahraman, A; Morris, RJ; Laskowski, RA; Thornton, JM. Shape variation in protein binding pockets and their ligands. J. Mol. Biol 2007, 368, 283–301. [Google Scholar]
  15. Laskowski, RA. SURFNET: A program for visualizing molecular surfaces, cavities, and intermolecular interactions. J. Mol. Graphics 1995, 13, 323–330. [Google Scholar]
  16. Levitt, DG; Banaszak, LJ. POCKET: A computer graphics method for identifying and displaying protein cavities and their surrounding amino acids. J. Mol. Graphics 1992, 10, 229–234. [Google Scholar]
  17. Kawabata, T; Go, N. Detection of pockets on protein surfaces using small and large probe spheres to find putative ligand binding sites. Proteins: Struct. Funct. Bioinf 2007, 68, 516–529. [Google Scholar]
  18. Weisel, M; Proschak, E; Schneider, G. PocketPicker: Analysis of ligand binding-sites with shape descriptors. Chem. Cent. J 2007, 1, 1–17. [Google Scholar]
  19. Li, B; Turuvekere, S; Agrawal, M; La, D; Ramani, K; Kihara, D. Characterization of local geometry of protein surfaces with the visibility criterion. Proteins: Struct. Funct. Bioinf 2008, 71, 670–683. [Google Scholar]
  20. Kalidas, Y; Chandra, N. PocketDepth: A new depth based algorithm for identification of ligand binding sites in proteins. J. Struct. Biol 2008, 161, 31–42. [Google Scholar]
  21. Liang, J; Edelsbrunner, H; Woodward, C. Anatomy of protein pockets and cavities: Measurement of binding site geometry and implications for ligand design. Protein Sci 1998, 7, 1884–1897. [Google Scholar]
  22. Huang, B; Schroeder, M. LIGSITEcsc: Predicting ligand binding sites using the Connolly surface and degree of conservation. BMC Struct. Biol 2006, 6, 19. [Google Scholar]
  23. Tseng, YY; Dundas, J; Liang, J. Predicting protein function and binding profile via matching of local evolutionary and geometric surface patterns. J. Mol. Biol 2009, 387, 451–464. [Google Scholar]
  24. Elcock, AH. Prediction of functionally important residues based solely on the computed energetics of protein structure. J. Mol. Biol 2001, 312, 885–896. [Google Scholar]
  25. Laurie, AT; Jackson, RM. Q-SiteFinder: An energy-based method for the prediction of protein– ligand binding sites. Bioinformatics 2005, 21, 1908. [Google Scholar]
  26. An, J; Totrov, M; Abagyan, R. Pocketome via comprehensive identification and classification of ligand binding envelopes. Mol. Cell. Proteomics 2005, 4, 752. [Google Scholar]
  27. Sael, L; Kihara, D. Protein surface representation and comparison: New approaches in structural proteomics. In Biological Data Mining; Chen, JY, Lonardi, S, Eds.; Chapman & Hall/CRC Press: Boca Raton, FL, USA, 2009aa; pp. 89–109. [Google Scholar]
  28. Porter, CT; Bartlett, GJ; Thornton, JM. The Catalytic Site Atlas: A resource of catalytic sites and residues identified in enzymes using structural data. Nucleic Acids Res 2004, 32, D129–D133. [Google Scholar]
  29. Arakaki, AK; Zhang, Y; Skolnick, J. Large-scale assessment of the utility of low-resolution protein structures for biochemical function assignment. Bioinformatics 2004, 20, 1087–1096. [Google Scholar]
  30. Ferrè, F; Ausiello, G; Zanzoni, A; Helmer-Citterich, M. SURFACE: A database of protein surface regions for functional annotation. Nucleic Acids Res 2004, 32, D240–D244. [Google Scholar]
  31. Gold, ND; Jackson, RM. Fold independent structural comparisons of protein-ligand binding sites for exploring functional relationships. J. Mol. Biol 2006, 355, 1112–1124. [Google Scholar]
  32. Kinoshita, K; Murakami, Y; Nakamura, H. eF-seek: Prediction of the functional sites of proteins by searching for similar electrostatic potential and molecular surface shape. Nucleic Acids Res 2007, 35, W398–W402. [Google Scholar]
  33. Morris, RJ; Najmanovich, RJ; Kahraman, A; Thornton, JM. Real spherical harmonic expansion coefficients as 3D shape descriptors for protein binding pocket and ligand comparisons. Bioinformatics 2005, 21, 2347–2355. [Google Scholar]
  34. Hoffmann, B; Zaslavskiy, M; Vert, J; Stoven, V. A new protein binding pocket similarity measure based on comparison of clouds of atoms in 3D: Application to ligand prediction. BMC Bioinformatics 2010, 11, 99. [Google Scholar]
  35. Canterakis, N. 3D Zernike moments and zernike affine invariants for 3D image analysis and recognition. 11th Scandinavian Conference on Image Analysis, Kangerlussuaq, Greenland, 7–11 June 1999.
  36. Baker, N; Holst, M; Wang, F. Adaptive multilevel finite element solution of the Poisson– Boltzmann equation II. Refinement at solvent-accessible surfaces in biomolecular systems. J. Comput. Chem 2000, 21, 1343–1352. [Google Scholar]
  37. Novotni, M; Klein, R. Proceedings of the eighth ACM symposium on solid modeling and applications. Proceedings of the Eighth ACM Symposium on Solid Modeling and Applications, Seattle, Washington, DC, USA, 16–20 June 2003; pp. 216–225.
  38. Venkatraman, V; Sael, L; Kihara, D. Potential for protein surface shape analysis using spherical harmonics and 3D Zernike descriptors. Cell Biochem. Biophys 2009, 54, 23–32. [Google Scholar]
  39. Kihara, D; Sael, L; Chikhi, R; Esquivel-Rodriguez, J. Molecular surface representation using 3D Zernike descriptors for protein shape comparison and docking. Curr Protein Peptide Sci, 2010; accepted. [Google Scholar]
  40. Sael, L; Li, B; La, D; Fang, Y; Ramani, K; Rustamov, R; Kihara, D. Fast protein tertiary structure retrieval based on global surface shape similarity. Proteins: Struct. Funct. Bioinf 2008, 72, 1259–1273. [Google Scholar]
  41. La, D; Esquivel-Rodríguez, J; Venkatraman, V; Li, B; Sael, L; Ueng, S; Ahrendt, S; Kihara, D. 3D-SURFER: Software for high-throughput protein surface comparison and analysis. Bioinformatics 2009, 25, 2843–2844. [Google Scholar]
  42. Sael, L; La, D; Li, B; Rustamov, R; Kihara, D. Rapid comparison of properties on protein surface. Proteins: Struct. Funct. Bioinf 2008, 73, 1–10. [Google Scholar]
  43. Venkatraman, V; Chakravarthy, PR; Kihara, D. Application of 3D Zernike descriptors to shape-based ligand similarity searching. J. Cheminformatics 2009, 1, 19. [Google Scholar]
  44. Venkatraman, V; Yang, YD; Sael, L; Kihara, D. Protein-protein docking using region-based 3D Zernike descriptors. BMC Bioinformatics 2009, 10, 407. [Google Scholar]
  45. Sael, L; Kihara, D. Protein surface representation for application to comparing low-resolution protein structure data. BMC Bioinformatics (GIW 2010 issue), 2010; in press. [Google Scholar]
  46. Demange, G; Gale, D; Sotomayor, M. Multi-item auctions. J. Polit. Economy 1986, 94, 863–872. [Google Scholar]
  47. Sael, L; Kihara, D. Characterization and classification of local protein surfaces using self-organizing map. Int. J. Knowl. Discov. Bioinformatics 2010, 1, 32–47. [Google Scholar]
Figure 1. Flow chart of the local surface patch prediction method.
Figure 1. Flow chart of the local surface patch prediction method.
Ijms 11 05009f1
Figure 2. Flow chart of pocket extraction and patch descriptor generation.
Figure 2. Flow chart of pocket extraction and patch descriptor generation.
Ijms 11 05009f2
Figure 3. Modified auction algorithm for bipartite matching. Modification to the original algorithm is indicated in red.
Figure 3. Modified auction algorithm for bipartite matching. Modification to the original algorithm is indicated in red.
Ijms 11 05009f3
Figure 4. Prediction performance using shape and pocket size information. ROC AUC values of pockets that bind to (A) ATP, FAD, FMN, NAD, and STR; (B) AMP, GLC, HEM, and PO4. (C) Average ROC AUC values over all ligand types. Top-3 prediction success rate of (D) ATP, FAD, FMN, NAD, and STR; (E) AMP, GLC, HEM, and PO4. (F) Average Top-3 success rate over all ligand types. *NT in x-axis denotes experiments with no threshold used.
Figure 4. Prediction performance using shape and pocket size information. ROC AUC values of pockets that bind to (A) ATP, FAD, FMN, NAD, and STR; (B) AMP, GLC, HEM, and PO4. (C) Average ROC AUC values over all ligand types. Top-3 prediction success rate of (D) ATP, FAD, FMN, NAD, and STR; (E) AMP, GLC, HEM, and PO4. (F) Average Top-3 success rate over all ligand types. *NT in x-axis denotes experiments with no threshold used.
Ijms 11 05009f4
Figure 5. The number of paired patches between same ligand types (red) and different ligand types (green).
Figure 5. The number of paired patches between same ligand types (red) and different ligand types (green).
Ijms 11 05009f5
Figure 6. An example of matched patches in NAD binding pockets. There are total of 4 matched patch pairs using the distance threshold, td, of 0.1; 24 matches using td = 0.15, and 34 matches using td ≥ 0.2. Each matched pair of patches between pockets in PDBID:1qax and PDBID:2a5f are marked with the same color.
Figure 6. An example of matched patches in NAD binding pockets. There are total of 4 matched patch pairs using the distance threshold, td, of 0.1; 24 matches using td = 0.15, and 34 matches using td ≥ 0.2. Each matched pair of patches between pockets in PDBID:1qax and PDBID:2a5f are marked with the same color.
Ijms 11 05009f6
Figure 7. Examples of matching patch pairs in AMP, ATP, NAD and FAD binding pocket using the distance threshold 0.30. The matched pairs which locate at equivalent position to adenosine monophosphate are shown in the same color.
Figure 7. Examples of matching patch pairs in AMP, ATP, NAD and FAD binding pocket using the distance threshold 0.30. The matched pairs which locate at equivalent position to adenosine monophosphate are shown in the same color.
Ijms 11 05009f7
Table 1. The average number of seed points for each ligand type in the benchmark dataset.
Table 1. The average number of seed points for each ligand type in the benchmark dataset.
Ligand typeAverage Number of Seed PointsMolecular mass (g/mol) a
AMP23.7347.22
ATP29.5507.18
FAD44.1785.55
FMN27.7456.34
GLC15.2180.16
HEM36.9616.49
NAD36.8663.43
PO49.794.97
STR22.2278.8
(a)These values are taken from Chikhi et al. [14].
Table 2. Average area under the ROC curves of different pocket descriptors.
Table 2. Average area under the ROC curves of different pocket descriptors.
2D Pseudo-Zernike a)2D Zernikea)Spherical Harmonics b)Global 3DZD a)Patch 3DZD
shape only0.660.660.640.660.76
shape + pocket size0.790.780.770.810.82
(a)The values are taken from Chikhi et al. [13].
(b)The values are taken from Kahraman et al. [14].
Table 3. Performance of the local patch method for individual ligand types.
Table 3. Performance of the local patch method for individual ligand types.
Descriptor typeRankAMPATPFADFMNGLCHEMNADPO4STRAverage
ShapeAUC0.720.740.800.570.720.920.690.830.850.76
Top10.110.140.400.000.001.000.000.900.000.28
Top30.670.930.900.000.401.000.601.000.800.70
Shape + sizeAUC0.850.760.830.680.880.910.740.880.850.82
Top10.670.430.600.000.400.940.001.000.000.45
Top31.000.930.900.500.801.000.801.000.800.86
Pocket Size aTop10.220.070.500.000.000.000.271.000.000.23
Top30.560.790.800.000.000.810.601.000.000.51
Random aTop 10.100.130.100.060.050.150.140.190.060.11
Top 30.280.400.310.210.170.450.420.550.190.33
(a)Values are taken from Table 4A of our previous work [13].
Table 4. Computation time determined on the Kahraman dataset.
Table 4. Computation time determined on the Kahraman dataset.
ProcessGlobal 3DZDPatch 3DZD
PreparationComputation of descriptor16 s a1 min 52.96 s
DatabaseDistance computations0.023 s a1.28 s
Ligand prediction0.02 s0.02 s
Total31.54 s2 min 29.76 s
(a)The computation time was taken from [13].

Share and Cite

MDPI and ACS Style

Sael, L.; Kihara, D. Binding Ligand Prediction for Proteins Using Partial Matching of Local Surface Patches. Int. J. Mol. Sci. 2010, 11, 5009-5026. https://doi.org/10.3390/ijms11125009

AMA Style

Sael L, Kihara D. Binding Ligand Prediction for Proteins Using Partial Matching of Local Surface Patches. International Journal of Molecular Sciences. 2010; 11(12):5009-5026. https://doi.org/10.3390/ijms11125009

Chicago/Turabian Style

Sael, Lee, and Daisuke Kihara. 2010. "Binding Ligand Prediction for Proteins Using Partial Matching of Local Surface Patches" International Journal of Molecular Sciences 11, no. 12: 5009-5026. https://doi.org/10.3390/ijms11125009

Article Metrics

Back to TopTop