Skip to main content

A novel neural response algorithm for protein function prediction

Abstract

Background

Large amounts of data are being generated by high-throughput genome sequencing methods. But the rate of the experimental functional characterization falls far behind. To fill the gap between the number of sequences and their annotations, fast and accurate automated annotation methods are required. Many methods, such as GOblet, GOFigure, and Gotcha, are designed based on the BLAST search. Unfortunately, the sequence coverage of these methods is low as they cannot detect the remote homologues. Adding to this, the lack of annotation specificity advocates the need to improve automated protein function prediction.

Results

We designed a novel automated protein functional assignment method based on the neural response algorithm, which simulates the neuronal behavior of the visual cortex in the human brain. Firstly, we predict the most similar target protein for a given query protein and thereby assign its GO term to the query sequence. When assessed on test set, our method ranked the actual leaf GO term among the top 5 probable GO terms with accuracy of 86.93%.

Conclusions

The proposed algorithm is the first instance of neural response algorithm being used in the biological domain. The use of HMM profiles along with the secondary structure information to define the neural response gives our method an edge over other available methods on annotation accuracy. Results of the 5-fold cross validation and the comparison with PFP and FFPred servers indicate the prominent performance by our method. The program, the dataset, and help files are available at http://www.jjwanglab.org/NRProF/.

Background

Recent advances in high-throughput sequencing technologies have enabled the scientific community to sequence a large number of genomes. Currently there are 1,390 complete genomes [1] annotated in the KEGG genome repository and many more are in progress. However, experimental functional characterization of these genes cannot match the data production rate. Adding to this, more than 50% of functional annotations are enigmatic [2]. Even the well studied genomes, such as E. coli and C. elegans, have 51.17% and 87.92% ambiguous annotations (putative, probable and unknown) respectively [2]. To fill the gap between the number of sequences and their (quality) annotations, we need fast, yet accurate automated functional annotation methods. Such computational annotation methods are also critical in analyzing, interpreting and characterizing large complex data sets from high-throughput experimental methods, such as protein-protein interactions (PPI) [3] and gene expression data by clustering similar genes and proteins.

The definition of biological function itself is enigmatic in biology and highly context dependent [4–6]. This is part of the reason why more than 50% of functional annotations are ambiguous. The functional scope of a protein in an organism differs depending on the aspects under consideration. Proteins can be annotated based on their mode of action, i.e. Enzyme Commission (EC) number [7] (physiological aspect) or their association with a disease (phenotypic aspect). The lack of functional coherence increases the complexity of automated functional annotation. Another major barrier is the use of different vocabulary by different annotations. A function can be described differently in different organisms [8]. This problem can be solved by using ontologies, which serve as universal functional definitions. Enzyme Commission (E.C) [9], MIPS Functional Catalogue (FunCat) [10] and Gene Ontology (GO) [11] are such ontologies. With GO being the most recently and widely used, many automated annotation methods use GO for functional annotation.

Protein function assignment methods can be divided into two main categories - structure-based methods and sequence-based methods. A protein's function is highly related to its structure. Protein structure tends to be more conserved than the amino acid sequence in the course of evolution [12, 13]. Thus a variety of structure-based function prediction methods [14, 15] rely on structure similarities. These methods start with a predicted structure of the query protein and search for similar structural motifs in various structural classification databases such as CATH [16] and SCOP [17] for function prediction. Structural alignments can reveal the remote homology for 80-90% of the entries in Protein Data Bank [18] even if no significant sequence similarity was found for the two proteins [19]. However, these methods are limited by the accuracy of the initial query structure prediction and the availability of the homologous structures in the structural databases. Despite of being highly accurate, the big gap between the number of sequences and their solved structures restricts the use of structure-based methods. Therefore, sequence-based methods are needed.

The main idea behind sequence-based methods is to compare the query protein to the proteins that are well characterized, and the function of the best hit is directly assigned to the query sequence. GO annotations are assigned to the BLAST search results [20] for the first time by GOblet [21] which maps the sequence hits to their GO terms. Later on the GO terms are given weights based on the E-value of the BLAST search by Ontoblast [22]. This was further refined in GOfigure [23] and GOtcha [24] by communicating the scores from one level to the other in the GO hierarchy tree. All these methods are based on the BLAST search results; thus they fail to identify the remote homologues with a higher E-value. This problem is tackled by the Protein Function Prediction (PFP) server [25], which replaces the BLAST with PSI-BLAST [26] and thus can detect remote homologues. The PFP server can predict the generalized function of protein sequences with remote homology, but with a trade-off of low specificity. FFPred [27] is the most recent protein function prediction server that builds Support Vector Machine (SVM) classifiers based on the extracted sequence features of the query sequence and thus it does not require prior identification of protein sequence homologues. However the server needs one SVM classifier for each GO term, which makes it computationally expensive. Furthermore, the server only provides classifiers for 111 Molecular function and 86 Biological Process categories that represent more general annotations, which limits its usage in deciphering specific annotations. The lack of annotation specificity and high complexity of the existing methods advocate the need of improvement in the automated protein function prediction.

Here we present a novel automated protein functional assignment method based on the neural response algorithm [28]. The algorithm simulates the neuronal behavior of human's image recognition, and has been successfully applied for image classification. The main idea of this algorithm is to define a distance metric that corresponds to the similarity of small patches of the images and reflects how the human brain can distinguish different images. This algorithm uses a multi-layer framework with spatial scale, and size increasing as we move from the one layer to the other in a bottom-up fashion. The bottom layer consists of templates (sub-patches) of the images and the intermediate layers consist of secondary templates formed by the assembly of the templates in the lower layers. The whole image is in the topmost layer. For example consider a three layered architecture of templates (patches) p, q and r (whole image), with p ⊂ q ⊂ r as shown in Figure 1. Let Im(p), Im(q) and Im(r) be the function spaces corresponding to the similarity of the templates in the layers p, q and r respectively. Im(x) gives the similarity between any two patches in the layer x and a mapping set m: that maps the templates from the bottom most layer to the templates in the next layer i.e. m p : p → q, and similarly m q : q → r. Having defined the layers (p, q and r) and the initial layers similarity function Im(p), the algorithm builds a derived kernel on the top of layer r in a bottom-up fashion. The process starts with the calculation of initial reproducing kernel k p on the bottom most layer p as the inner product of its functional space Im(p)×Im(p). Based on the this initial kernel k p , intermediate derived kernel k q is computed on top of the layer q and this in turn is used to compute the final derived kernel k r on the top most layer r, which can help us in the classification of the whole images in layer r. Refer to [28], for the detailed mathematical formulation of the initial and the derived kernels. The computation of kernels forms the unsupervised preprocessing component and is key for the superior performance of the neural response algorithm as it can minimize the complexity of the corresponding image classification problem (supervised task)[28].

Figure 1
figure 1

Three layer mode for image classification.

In the current context of protein functional characterization, the top layer represents the whole protein sequences and the subsequent layers are constituted of sequence motifs. At each layer similarity is computed between the templates of two successive layers, which are referred to as derived kernels by taking the maximum of the previously computed local kernels in a recursive fashion. Finally a mapping engine is built on the kernels derived from the neural response algorithm to map the query protein to its most probable GO term. A detailed description of the whole methodology is given in the Methods section.

Results

We used the GO terms with no further children (leaf nodes of the GO tree) and their corresponding proteins for the assessment of our method. The rationale for using leaf nodes is that these GO terms are functionally more specific than the GO terms at the higher levels, i.e. no two GO terms should share a common protein and thus can demonstrate the specific function prediction strength of our method. This also addresses the issue of redundancy in the training set. To further fortify our argument we had also addressed the redundancy problem at sequence level by eliminating the redundant sequences that are more than 80% similar in the training set. This was done by using CD-HIT [29], a program that removes redundant sequences and generates a database of only the representatives. From the extracted GO terms we enumerated all the protein pairs belonging to the same GO term and labeled them as positive dataset i.e. we assigned a label Y (i, j) as 1 and the protein pairs belonging to different GO terms were labeled as negative, Y (i, j) = 0. Among such labeled pairs, we randomly selected 3000 positive pairs and 3000 negative pairs and used these labeled protein pairs to train and validate our method. After training the final mapping function, f(N (i, j) ) produced a value between 0 and 1 corresponding to the similarity between the proteins i and j in the validation set. Upon applying the threshold of 0.5, we predicted the labels Y (i, j) to 1 (share a GO term) if f(N (i, j) ) ≥ 0.5, and predict Y (i, j) to 0 (do not share a GO term) if f(N (i, j) ) < 0.5.

Cross validation

To evaluate our method we performed 5-fold cross validation i.e. we randomly divided the pool of 6000 labeled protein pairs into five partitions with an equal number of positive and negative labeled pairs. Out of the five partitions, four were used to train the neural response algorithm, and the remaining one partition was used to test the algorithm. This process was repeated for five time (the folds), with each of the five partitions used exactly once as the validation data. The idea was to check whether our method can correctly classify the pairs, which were not used for training. The values of average accuracy, area under the curve (AUC) and training time of the 5-fold cross validation are reported in Table 1, with respect to the template library and the mapping engine used (See Methods). The difference in the accuracies using the PROSITE and PFAM template libraries is due to the differences in the respective sequence coverage. Thus we combined the PFAM and PROSITE templates for a better sequence coverage, and indeed, the accuracy increased (Table 1). Out of the two mapping engines Least Squares classifier is almost 3 folds faster than the SVM classifier with almost the same accuracy (Table 1). Therefore we report the accuracy values using the Least Squares mapping engine.

Table 1 5 Fold cross validation results with respect to the template library

Classification specificity with respect to the GO term distance

As described in methods, the derived kernel classifies two proteins to be similar, if the pair is equivalent (similar) to a pair with two known similar proteins. To test the classification specificity of our method, we have selected 800 proteins (400 pairs) with the first 100 pairs sharing an immediate parent GO term (level 1); second 100 pairs sharing a common parent separated by an edge distance of 2 in the GO tree (level 2). Similarly we have level 3 and 4 datasets with an edge distance of 3 and 4 respectively. As the positive pairs in the training set share a common GO term, we expect our method to classify the protein pairs as positive whose GO terms are the same or the next one in the GO hierarchy and as negative if their respective GO terms are far away. The number of positively classified (similar) pairs in respective subsets is given the Figure 2. We observed that the proportion of positively classified (similar) pairs is 88% in the level 1 dataset as they are much closer in the GO tree and it gradually dropped to 9% in the level 4 dataset as the GO distance between them is increased. This suggests that our method is highly specific in classifying the similar proteins with respect to the relative distance between the respective GO terms.

Figure 2
figure 2

Classification specificity plot.

Comparison of classification accuracy

Having shown the predominant classification specificity and the 5 fold cross validation results, we further compare the classification accuracy of our method with the PFP and FFPred servers, which are the most sensitive protein function prediction server using GO vocabulary [3] to date. We had compiled a test set of 400 proteins constituting of 200 protein pairs, with 100 pairs sharing the same GO term (positive test set) i.e. the edge distance between the GO terms of a protein pair is zero and other 100 pairs sharing a distant root GO term (negative test set) i.e. the edge distance between the GO terms of a protein pair is ≥ 1. Each of the 200 protein pairs were classified as either positive (similar) or negative (non similar) by NRProF. Since PFP or FFPred server does not have a standalone software version, we had to submit our query directly to the online server manually for each of the 400 proteins. The PFP and FFPred servers list the probable GO terms for a query protein sequence with a confidence score associated with each of the GO terms. A classification is considered to be accurate if the servers predict the same GO term (rank 1) for both the proteins of a pair in the positive test set and different for the negative test set. On the other hand NRProF classification is considered to be accurate if it can classify the positive set as similar and negative set as dissimilar pairs. Out of 200 predictions, NRProF performed better than PFP and FFPred servers in 8 and 5 instances respectively. The accuracies are tabulated in Table 2. We therefore conclude that NRProF has a better classification accuracy.

Table 2 Classification Accuracy of the NRProF, FFPred and PFP server with respect to the compiled test set.

GO term predictability

Next we demonstrate the GO term predictability of our method. Our method labels a protein pair p i (query protein) and p j (protein in the base dataset) as 1 if they are similar and thereby assigns the GO term of the protein p j to the protein p i based on the threshold applied on the function f(N (i, j) ). To overcome the threshold dependency and to make the results comparable with the PFP and FFPred servers, we had sorted the proteins in the base dataset in descending order based on their similarity (f(N (i, j) )) to the query protein, and assigned the GO term of the corresponding most similar (rank 1) protein to the query protein. For a better understanding of the methods, we present the stepwise workout of the algorithm for a human protein Chromodomain Helicase DNA binding protein 1 (Figure 3). Firstly the query sequence CHD1 was scanned for the potential template hits. We got 7 hits in the template library, with no hit occurring more than once thus a neural response vector can be computed with equation 4 (see Methods). The neural response vector computed was < CHD1 |PS50013, 15.363 | PS50079, 4 | PS50313, 9.155 | PS50322, 9.138 | PS50324, 24.763 | PS51192, 25.932 | PS51194, 19.905 | >. The first element in the vector is the query protein followed by the template ID (Prosite/Pfam) and its score respectively. However if the query sequence have repeats or if a template t has more than one hit in the query sequence we consider the hit with the maximum score (equation 3, Methods). We then calculated the pair wise neural response N(p, q j ) (equation 5, Methods) where p is the query (CHD1) and q i is the pre-computed neural response of the ith protein sequence from the initial base set. For illustration here we show the calculation of 3 pair wise neural response vectors (CHD1-AAAS), (CHD1-CHD2) and (CHD1-CDV3) in the Figure 3. Next these pair wise neural response vectors together with the another pair wise neural response vector (which is known to be similar) were fed to the mapping function using a Gaussian kernel (equation 7, Methods) to generate a value ranging from 0 to 1 corresponding to the similarity between the proteins in the pair wise neural response. Then we sorted the proteins in the base dataset in a descending order based on their similarity (f(N (i, j) )) to the query protein. Since the f(N( CHD1-CHD2 ) is higher than the other two, we assigned the GO term of CHD2 to CHD1. In the GO tree, CHD2 has 22 associated GO terms. Since we considered only leaf GO terms for the higher annotation specificity, we assigned the GO term GO:0005524 (leaf GO term associated with CHD2) to CHD1. However, in addition to the current state of the algorithm if users wish to consider other non-leaf GO terms, we suggest the users to use the sequence diversity (simply the number of representative sequences after the CD-HIT filtration) in the GO terms associated with the most similar protein to the query protein, as a criteria for assigning the GO term i.e., the GO term with the least sequence diversity is assigned to the query protein. This can be advocated by the fact that the sequence diversity is inversely proportional to the specificity of the GO terms. In the current example by either ways our method had assigned the term GO:0005524 to the CHD1.

Figure 3
figure 3

Detailed workout of CHD1. (a) Query sequence CHD1 is scanned for the potential template hits. (b) Computation of the corresponding neural response. (c) Calculation of pair wise neural response N(p, q j ) viz. (CHD1-AAAS), (CHD1-CHD2) and (CHD1-CDV3). (d) Database of pre-computed neural response for the base dataset. (e) The pair wise pair wise neural response vectors are fed to the mapping function using a Gaussian kernel to generate a value ranging from 0 to 1. (f) Proteins in the base dataset ate sorted in descending order based on their similarity (f(N (i, j) )) to the query protein. (g) GO term GO:0005524 of CHD2, with high mapping score is assigned to CHD1.

Comparison with the existing methods

We compared the GO term predictions of our method with PFP and FFPred servers, which are the most sensitive function prediction servers to date. PFP and FFPred servers predict the most probable GO terms for a query protein with a confidence score associated with each of the GO terms. A prediction is considered to be accurate if actual (most specific) GO term of the query protein is ranked among the top 5 probable GO terms by the respective methods. Lack of standalone versions of PFP and FFPred is a serious limitation on the dataset used for comparison. We compiled a dataset of 300 proteins each belonging to the leaf nodes of the GO tree. The prediction results from PFP and FFpred were obtained by manual submissions to the respective servers. Table 3 compares the GO terms predicted for the Human protein WDR55. PFP could not report the actual leaf GO term in its top 5 predictions. This is due to trade-off of annotation specificity to weak hits with High e value. FFPred could not predict any GO term because it is limited to only 111 Molecular function and 86 Biological Process categories. Whereas NRProF predicted top 3 similar proteins with the same GO term. The Overall accuracy on the set of 300 proteins is reported in the Table 4.

Table 3 GO terms predicted for the protein Q9H6Y2 by PFP, FFPred and NRProF.
Table 4 GO term prediction Accuracy of the NRProF and PFP server with respect to the test set.

From Table 4, we can infer that our method NRProF performs reasonably better than the PFP server. We have not reported the accuracy of the FFPred, as it is limited to only 111 Molecular function categories, which makes it suitable for general rather than specific function annotations. There are other methods that use GO vocabulary for protein function prediction methods including GOblet, GOfigure and GOtcha. But the PFP server has already been proved to be superior to all the above mentioned methods [25]. Thus we have compared our method (NRProF) only with the PFP server.

Discussion

Mapping function threshold

The mapping function, f(N (i, j) ) produces a value between 0 and 1 corresponding to the similarity between the proteins i and j. Upon applying the threshold of 0.5, we assign the labels Y (i, j) to 1 (share a GO term) if f(N (i, j) ) ≥ x, and to 0 (do not share a GO term) if f(N (i, j) ) < x. We tried different values of x to decide on the best threshold. Different threshold values and their corresponding accuracies are plotted in Figure 4. It can be observed that the accuracy is high for the threshold values ranging from 0.5 to 0.6. Thus we selected 0.5 as the optimal cut-off.

Figure 4
figure 4

Accuracy plot for different threshold values.

CD-HIT threshold

Here all our validation and test data sets constitute of Human GO terms (same species) thus we need to take care of the redundancy. This was implicitly addressed by using GO nodes with no children; however we even address this issue at the protein sequence level by using CD-HIT with optimal cut-off, to ensure proper training. An optimal threshold should not be too high or too low, if so the predictions will be biased towards highly similar/dissimilar proteins respectively. In order to observe the influence of this cut-off on the accuracy, we compared the accuracy values on a test set of 2000 protein pairs, with 1000 positive and 1000 negative pairs with respect to five different cut-offs and the results are shown in the Table 5. We can observe that the accuracies at 60% and 100% cut-offs are less when compared to others. This may be due to the biased training on negative and positive protein pairs respectively. The accuracies at 70% and 80% are almost as good as or higher than the other cut-offs. This supports the use of 80% as the cut-off to eliminate the redundancy. However this cut-off should be changed with the addition of sequences from the other species. Thus we advise to choose the cut-off based on the diversity of the dataset.

Table 5 Impact of CD-Hit cut-off on the accuracy

Similarity based on protein pairs

We can simply calculate the similarity between a query protein and a known one to assign the corresponding GO term. However with this similarity, we can only use some naive algorithms like k-nearest neighborhood, whose accuracy is not quite satisfactory especially for biological data (proteins), which is essentially multi dimensional. In addition to this, we should artificially enforce a similarity cut-off between the query and the known protein to assign the query protein to its associated GO category. Considering the fact that the intra GO term similarity varies from GO term to GO term it is difficult to set such cut-offs. To conquer this, it is necessary to design a machine learning algorithm that can learn and chose the cut-off based on the similarity between the proteins sharing the same GO term i.e. the similarity cut-off should be high if the intra GO term similarity is high and vice versa. Here, our model assigns the query protein to its associated GO category (1st pair) based on the respective Intra GO term similarity, given by the similarity between the proteins constituting the 2nd pair, i.e. the 1st pair will be labeled as similar if its similarity is equivalent to the similarity of the 2nd pair (labeled as similar) and vice versa. By this we can bypass the cut-off that needs to be enforced on the simple similarity score for assigning GO terms.

GO term mapping

Mapping contains entities from external database system indexed to similar or related GO terms. Currently these mappings in the Gene Ontology database are made manually consuming a lot of resources and time. As a spin-off, our methodology can automate the process of mapping between the templates (Prosite/Pfam) and the GO terms, without compromising much on the accuracy. The neural response of a protein with respect to all the templates computed according to the equations 4 (Methods) is nothing but the mapping of a protein (GO term) to the respective templates (motifs). GO-Motif association scores for the same is given by:

s i = N M i × ( A S ) i
(1)

where NM i is the number of proteins (after removing the redundancy by CD-HIT) having a specific motif i associated to a GO term (motif frequency) and AS i is the alignment strength of the respective motif's. We use the product of NM i and AS i to achieve a trade-off between the overrepresentation of a motif to its alignment strength. The detailed calculation is shown in Figure 5. The computed GO-Motif association scores can be used to rank the multiple mappings to a GO term.

Figure 5
figure 5

GO tem mapping with respect to the template library.

Proteins with multiple leaf GO terms

Our test set is compiled of leaf GO terms and their corresponding proteins with no two GO terms sharing a common protein, to demonstrate the specific function prediction strength of our method. However, up on perusal we found that ~25% of the proteins belong to more than one leaf GO term under the category of molecular function. To analyse the effect of "not including such proteins" on the accuracy, we have compiled a new test set of the same size (300 proteins including proteins belonging to more than one leaf GO term). We perceive that considering proteins belonging to more than one leaf GO term has no negative effect on the GO term predictability. In fact the prediction accuracy is slightly better 89.63% when compared to 86.93% on the actual test set.

Conclusions

Here we present a novel protein function prediction method, NRProF, based on the neural response algorithm using the Gene Ontology vocabulary. The neural response algorithm simulates the neuronal behavior of the visual cortex in the human brain. It defines a distance metric corresponding to the similarity by reflecting how the human brain can distinguish different sequences. It adopts a multi-layer structure, in which each layer can use one or multiple types of sequence/structure patterns.

NRProF is the first instance of neural response being used in the biological domain. It finds the most similar protein to the query protein based on the neural response N between the query and the target sequences; and thereby assigns the GO term(s) of the most similar protein to the query protein. This is a profound and composite method with the essence of sequential, structural and evolutionary based methods for protein function prediction. The templates from the PRINTS and PFAM database contribute to the functional profiles or signatures (sequence). The mismatch and deletion states in the HMM profiles of the PFAM templates account to the degeneracy due to evolution and the secondary structural information of the match states in the HHM profiles contribute to the structural part. The use of HMM profiles along with the secondary structure information of PROSITE and PFAM sequence motifs to define the neural response gives our method an edge over other available methods to identify the remote homologues, as profile-profile alignments are superior to PSI-BLAST based methods in detecting the remote homologues. Thus NRProF can complement most of the existing methods.

Our method is computationally less complex compared with the other methods, as the initial neural response of the proteins in the base dataset with respect to the template library are computed only once and from there the neural response between the query and target is computed with the least computational effort unlike other BLAST/PSI-BLAST based methods. The simple derived kernel adds to the computational simplicity of our method. We validated our method in a 5-fold cross validation fashion and obtained an accuracy of 82%. Considering the criterion that a prediction is valid if and only if the actual GO term is top ranked (1st Rank) GO term by our method, 82% is quite a good accuracy. The classification accuracy of 83.8% on a test set of 400 proteins suggests that our method is highly specific in classifying the similar proteins with respect to the relative distance between the respective GO terms. Upon further caparison of our method with the PFP and FFPred servers which are the most sensitive function prediction servers to date, the GO term prediction accuracy of 86.93% evince that our method is more accurate in predicting the specific functions. Thus we conclude that our method is computationally simple yet accurate when compared with the other methods. This is achieved by simulating the neuronal behavior of the visual cortex in the human brain in the form of neural response.

Methods

The neural response algorithm can be viewed as a multi-layered framework as described in the background section. Here we built a two layer model as shown in Figure 6, with the whole protein sequences in the top most layer and the templates (sequence motifs) in the subsequent layer. We used Gene Ontology (GO) vocabulary for protein functional assignment, i.e. we mapped the query protein to its corresponding GO term(s) that represent(s) the properties of the query sequence. GO terms covers three major domains: cellular component, molecular function, and biological process. We downloaded the ontology file (OBO) v1.2 from the GO resource.

Figure 6
figure 6

Two layers of the model and their respective data sources.

To demonstrate our approach, we only used the molecular function domain with a total of 8,912 GO terms. Then we extracted the proteins and their sequences belonging to each of the GO terms. To address the issues of redundancy we had used CD-HIT [29], a program that removes redundant sequences and generate a database of only the representatives. These protein sequences and their respective GO terms were used as the base dataset for our model. We only used proteins from humans because we wanted to demonstrate the ability of our method to predict/characterize the function of the proteins even if they are remotely homologous to the pre-characterized proteins (human).

We further trimmed our GO terms by screening out the terms with less than 5 proteins. The resultant GO terms form the base set for our method and their associated proteins form the top layer in the model. For the bottom layer (template library), we used the sequence motifs from PROSITE [30] version-20.68 and Pfam [31] version-24. The rationale behind choosing PROSITE and Pfam is that Pfam has the largest sequence coverage [3] and PROSIRE has small sequence motifs that can be useful in detecting remote homologues in the absence of a whole conserved domain. We downloaded the PROSITE patterns and Pfam domains as Hidden Markov Model (HMM) [32] files from the respective repositories. Here we built two kernels, one on the top of each layer. First an initial kernel is computed on top of the template layer, which can be used as a similarity function between the templates. Then a derived kernel is computed on top of the top layer by choosing the maximum neural response between the individual templates in bottom layer and the sequences in top layer. Computation of the initial kernel, the neural response and the derived kernel is explained in detail in the following subsections and the overall pipeline of the methodology is shown in Figure 7.

Figure 7
figure 7

Pipeline diagram showing the control flow of the method.

Initial kernel

Let there be m templates (sequence motifs) q 1 ...q m in the bottom layer. We need to define a non-negative similarity measure s(q i , q j ) between any two motifs q i and q j . A natural condition for similarity is s(q i , q j ) ≤ s(q i , q i ) for any q i ≠ q j , which means a motif is always more similar to itself than to the others. Besides this, to ensure the validity of our algorithm, a mathematical requirement of the similarity is that for a set of motifs q 1 ...q m , the matrix S should be a positive definite matrix.

S= s q i , q j i , j = 1 n
(2)

Our template library in bottom layer consists of HMM profiles from the Pfam database, thus we define the similarity between templates as profile-profile alignment scores. We had 10,257 profiles in the template library, making ~106 profile-profile alignments. To align the template HMM profiles we used HHsearch which is the most sensitive profile-profile alignment tool to date [33–35]. As a refinement for better sensitivity and to capture the remote homology between the templates, we considered the secondary structure information of the templates as well, which is considered more conserved and provides additional information [36]. We have previously used secondary structure information to improve protein sequence alignment [37] and remote homologue identification [38]. Thus we converted the HMM profiles to HHM [34] profiles containing the secondary structure information of all the match states in the HMM profiles. We employed HHsearch which uses PSI-PRED [39] to predict the secondary structure and added them to the HMM profiles. By doing this we were able to capture the remote homologues templates. Profile-Profile alignments were proved to be more sensitive than PSI-BLAST in the identification of remote similarity [40]. Thus our method has the edge over the PFP server which is based on PSI-BLAST in detecting the remote homologues.

Neural response

Consider a protein p in top layer with k template hits denoted by q p1 ...q pk in bottom layer. PrositeScan [41] and HMMER 3.0 [32] are used to scan the protein sequences in top layer with the templates from PROSITE and Pfam respectively. Both PrositeScan and HMMER 3.0 were used in the local alignment mode as here we intended to capture the existence of the locally conserved patterns. Then the neural response of the protein p with respect to a motif q is given by:

N p , q =max s q p 1 , q … q p k , q
(3)

Now by considering all the m motifs in the template layer the information about the protein p given the templates can be represented by an m-dimensional vector:

N p = N p , q 1 , … . N p , q m
(4)

Our goal is to learn the similarity between the query protein p i and the proteins in the base dataset such that we can assign the query protein p i to the GO term(s) associated with the most similar protein p j . To quantize the similarity between pairs p i and p j , we encoded the pair (p i , p j ) into a vector N (i, j) on which we can formulate the mapping engine to map the query protein to its most probable GO term. There are two ways to achieve this, by taking the difference between N(p i ) and N(p j ) or by simply concatenating them together. As we found that the former method always gives better performance in our algorithm, we thus let:

N ( i , j ) = N p i - N p j
(5)
= ( N p i , q 1 - N p j , q 1 , … , N p i , q m - N p j , q m )

which is the neural response of the pair (p i , p j ) on the templates set q 1 ...q m .

Derived kernel

We can derive a kernel K, which measures the similarity of two protein pairs, from the neural responses. This kernel also gives the similarity of two proteins. Two proteins are similar, if the pair constituted by them is similar to a pair with two similar proteins and vice visa. In the original paper of neural response [28], a linear kernel is defined by inner products of neural responses. Under our setting, the linear kernel for two pairs (p i , p j ) and (p i , p j ) can be written as

K p i , p j , p i ″ , p j ″ =N N i , j , N ( i ″ , j ″ )
(6)
= ∑ k = 1 n N ( p i , q k ) N p i ″ , q k + ∑ k = 1 n N p j , q k N p j ″ , q k

It is well established that the Gaussian kernel usually performs better than the linear kernel for various classification tasks. Thus we had derived a Gaussian kernel with a scale parameter σ, given by

K p i , p j , p i ″ , p j ″ =exp - N i , j - N ( i ″ , j ″ ) 2 σ 2
(7)

Mapping engine

Finally, a mapping engine was built, which defines a function "f" lying in the reproducing kernel Hilbert space [42] associated with a positive definite kernel K that is derived from the neural responses by inner products (linear kernel) or Gaussian radial basis functions (Gaussian kernel). First, we computed the neural response of all the proteins in the base dataset with respect to the template library in top layer. Similar neural response was computed for the query protein sequence as well. Next we computed the pair wise neural response N (i, j) between the query sequence i and the sequence j (1..n) in the base dataset. The mapping function f(N (i, j) ) produces a value ranging between 0 to 1 corresponding to similarity between the proteins p i and p j . Thus, we can predict the label Y (i, j) to 1 (similar) if f(N (i, j) ) ≥ 0.5, and Y (i, j) to 0 (non-similar) if f(N (i, j) ) < 0.5 . Other thresholds besides 0.5 are also allowed. We then assigned the query protein p i to the GO term/s associated with the protein/s p j whose label Y (i, j) was set to 1. In this case the sensitivity of GO term assignments varies with the threshold used (0.5). To overcome this dependency on the threshold, we sorted the proteins in the base dataset into descending order based on their similarity (f(N (i, j) )) to the query protein. We finally extracted the top 5 GO terms and assign them to the query protein. By doing so, we are not only overcoming the threshold dependency problem but also using the ranking (true value of the f(N (i, j) )) as the confidence scores for multiple GO terms associated with a single protein.

We used two popular classification engines viz., Support vector Machines (SVM) [43] and Least-Squares classifier [44] as the mapping engine. The main difference between them is, the loss function used for training. They use hinge loss and leastsquare loss respectively. The performance of two mapping engines is evaluated in the Results section.

References

  1. Kanehisa M, Goto S, Kawashima S, Okuno Y, Hattori M: The KEGG resource for deciphering the genome. Nucleic Acids Res. 2004, 32: D277-280. 10.1093/nar/gkh063.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  2. Hawkins T, Kihara D: Function prediction of uncharacterized proteins. J Bioinform Comput Biol. 2007, 5 (1): 1-30. 10.1142/S0219720007002503.

    Article  CAS  PubMed  Google Scholar 

  3. Hawkins T, Chitale M, Luban S, Kihara D: PFP: Automated prediction of gene ontology functional annotations with confidence scores using protein sequence data. Proteins. 2009, 74 (3): 566-582. 10.1002/prot.22172.

    Article  CAS  PubMed  Google Scholar 

  4. Whisstock JC, Lesk AM: Prediction of protein function from protein sequence and structure. Q Rev Biophys. 2003, 36 (3): 307-340. 10.1017/S0033583503003901.

    Article  CAS  PubMed  Google Scholar 

  5. Skolnick J, Fetrow JS: From genes to protein structure and function: novel applications of computational approaches in the genomic era. Trends Biotechnol. 2000, 18 (1): 34-39. 10.1016/S0167-7799(99)01398-0.

    Article  CAS  PubMed  Google Scholar 

  6. Rost B, Liu J, Nair R, Wrzeszczynski KO, Ofran Y: Automatic prediction of protein function. Cell Mol Life Sci. 2003, 60 (12): 2637-2650. 10.1007/s00018-003-3114-8.

    Article  CAS  PubMed  Google Scholar 

  7. Doolittle RF: The multiplicity of domains in proteins. Annu Rev Biochem. 1995, 64: 287-314. 10.1146/annurev.bi.64.070195.001443.

    Article  CAS  PubMed  Google Scholar 

  8. Valencia A: Automatic annotation of protein function. Curr Opin Struct Biol. 2005, 15 (3): 267-274. 10.1016/j.sbi.2005.05.010.

    Article  CAS  PubMed  Google Scholar 

  9. Nomenclature committee of the international union of biochemistry and molecular biology (NC-IUBMB), Enzyme Supplement 5 (1999). Eur J Biochem. 1999, 264 (2): 610-650.

    Google Scholar 

  10. Ruepp A, Zollner A, Maier D, Albermann K, Hani J, Mokrejs M, Tetko I, Guldener U, Mannhaupt G, Munsterkotter M, et al: The FunCat, a functional annotation scheme for systematic classification of proteins from whole genomes. Nucleic Acids Res. 2004, 32 (18): 5539-5545. 10.1093/nar/gkh894.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  11. Harris MA, Clark J, Ireland A, Lomax J, Ashburner M, Foulger R, Eilbeck K, Lewis S, Marshall B, Mungall C, et al: The Gene Ontology (GO) database and informatics resource. Nucleic Acids Res. 2004, 32: D258-261. 10.1093/nar/gkh036.

    Article  CAS  PubMed  Google Scholar 

  12. Gille C, Goede A, Preissner R, Rother K, Frommel C: Conservation of substructures in proteins: interfaces of secondary structural elements in proteasomal subunits. J Mol Biol. 2000, 299 (4): 1147-1154. 10.1006/jmbi.2000.3763.

    Article  CAS  PubMed  Google Scholar 

  13. Wilson CA, Kreychman J, Gerstein M: Assessing annotation transfer for genomics: quantifying the relations between protein sequence, structure and function through traditional and probabilistic scores. J Mol Biol. 2000, 297 (1): 233-249. 10.1006/jmbi.2000.3550.

    Article  CAS  PubMed  Google Scholar 

  14. Pal D, Eisenberg D: Inference of protein function from protein structure. Structure. 2005, 13 (1): 121-130. 10.1016/j.str.2004.10.015.

    Article  CAS  PubMed  Google Scholar 

  15. Ponomarenko JV, Bourne PE, Shindyalov IN: Assigning new GO annotations to protein data bank sequences by combining structure and sequence homology. Proteins. 2005, 58 (4): 855-865. 10.1002/prot.20355.

    Article  CAS  PubMed  Google Scholar 

  16. Orengo CA, Michie AD, Jones S, Jones DT, Swindells MB, Thornton JM: CATH--a hierarchic classification of protein domain structures. Structure. 1997, 5 (8): 1093-1108. 10.1016/S0969-2126(97)00260-8.

    Article  CAS  PubMed  Google Scholar 

  17. Murzin AG, Brenner SE, Hubbard T, Chothia C: SCOP: a structural classification of proteins database for the investigation of sequences and structures. J Mol Biol. 1995, 247 (4): 536-540.

    CAS  PubMed  Google Scholar 

  18. 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 (1): 235-242. 10.1093/nar/28.1.235.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  19. Orengo CA, Pearl FM, Bray JE, Todd AE, Martin AC, Lo Conte L, Thornton JM: The CATH Database provides insights into protein structure/function relationships. Nucleic Acids Res. 1999, 27 (1): 275-279. 10.1093/nar/27.1.275.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  20. Altschul SF, Gish W, Miller W, Myers EW, Lipman DJ: Basic local alignment search tool. J Mol Biol. 1990, 215 (3): 403-410.

    Article  CAS  PubMed  Google Scholar 

  21. Groth D, Lehrach H, Hennig S: GOblet: a platform for Gene Ontology annotation of anonymous sequence data. Nucleic Acids Res. 2004, 32: W313-317. 10.1093/nar/gkh406.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  22. Zehetner G: OntoBlast function: From sequence similarities directly to potential functional annotations by ontology terms. Nucleic Acids Res. 2003, 31 (13): 3799-3803. 10.1093/nar/gkg555.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  23. Khan S, Situ G, Decker K, Schmidt CJ: GoFigure: automated Gene Ontology annotation. Bioinformatics. 2003, 19 (18): 2484-2485. 10.1093/bioinformatics/btg338.

    Article  CAS  PubMed  Google Scholar 

  24. Martin DM, Berriman M, Barton GJ: GOtcha: a new method for prediction of protein function assessed by the annotation of seven genomes. BMC Bioinformatics. 2004, 5: 178-10.1186/1471-2105-5-178.

    Article  PubMed Central  PubMed  Google Scholar 

  25. Hawkins T, Luban S, Kihara D: Enhanced automated function prediction using distantly related sequences and contextual association by PFP. Protein Science. 2006, 15 (6): 1550-1556. 10.1110/ps.062153506.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  26. Altschul SF, Madden TL, Schaffer AA, Zhang J, Zhang Z, Miller W, Lipman DJ: Gapped BLAST and PSI-BLAST: a new generation of protein database search programs. Nucleic Acids Res. 1997, 25 (17): 3389-3402. 10.1093/nar/25.17.3389.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  27. Lobley AE, Nugent T, Orengo CA, Jones DT: FFPred: an integrated feature-based function prediction server for vertebrate proteomes. Nucleic Acids Res. 2008, 36: W297-302. 10.1093/nar/gkn193.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  28. Smale S, Rosasco L, Bouvrie J, Caponnetto A, Poggio T: Mathematics of the Neural Response. Foundations of Computational Mathematics. 2010, 10 (1): 67-91. 10.1007/s10208-009-9049-1.

    Article  Google Scholar 

  29. Huang Y, Niu B, Gao Y, Fu L, Li W: CD-HIT Suite: a web server for clustering and comparing biological sequences. Bioinformatics. 2010, 26 (5): 680-682. 10.1093/bioinformatics/btq003.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  30. Bairoch A: PROSITE: a dictionary of sites and patterns in proteins. Nucleic Acids Res. 1991, 19 (Suppl): 2241-2245. 10.1093/nar/19.suppl.2241.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  31. Sonnhammer EL, Eddy SR, Durbin R: Pfam: a comprehensive database of protein domain families based on seed alignments. Proteins. 1997, 28 (3): 405-420. 10.1002/(SICI)1097-0134(199707)28:3<405::AID-PROT10>3.0.CO;2-L.

    Article  CAS  PubMed  Google Scholar 

  32. Durbin R, Eddy S, Krogh A, Mitchison G: Biological sequence analysis: probabilistic models of proteins and nucleic acids. 1998, Cambridge University Press

    Chapter  Google Scholar 

  33. Sadreyev RI, Baker D, Grishin NV: Profile-profile comparisons by COMPASS predict intricate homologies between protein families. Protein Sci. 2003, 12 (10): 2262-2272.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  34. Soding J: Protein homology detection by HMM-HMM comparison. Bioinformatics. 2005, 21 (7): 951-960. 10.1093/bioinformatics/bti125.

    Article  PubMed  Google Scholar 

  35. Dunbrack RL: Sequence comparison and protein structure prediction. Curr Opin Struct Biol. 2006, 16 (3): 374-384. 10.1016/j.sbi.2006.05.006.

    Article  CAS  PubMed  Google Scholar 

  36. Wang JW, Feng JA: Exploring the sequence patterns in the alpha-helices of proteins. Protein Engineering. 2003, 16 (11): 799-807. 10.1093/protein/gzg101.

    Article  CAS  PubMed  Google Scholar 

  37. Wang JW, Feng JA: NdPASA: A novel pairwise protein sequence alignment algorithm that incorporates neighbor-dependent amino acid propensities. Proteins. 2005, 58 (3): 628-637.

    Article  CAS  PubMed  Google Scholar 

  38. Li W, Wang JW, Feng JA: NdPASA: a pairwise sequence alignment server for distantly related proteins. Bioinformatics. 2005, 21 (19): 3803-3805. 10.1093/bioinformatics/bti619.

    Article  CAS  PubMed  Google Scholar 

  39. McGuffin LJ, Bryson K, Jones DT: The PSIPRED protein structure prediction server. Bioinformatics. 2000, 16 (4): 404-405. 10.1093/bioinformatics/16.4.404.

    Article  CAS  PubMed  Google Scholar 

  40. Soding J, Biegert A, Lupas AN: The HHpred interactive server for protein homology detection and structure prediction. Nucleic Acids Res. 2005, 33: W244-248. 10.1093/nar/gki408.

    Article  PubMed Central  PubMed  Google Scholar 

  41. Gattiker A, Gasteiger E, Bairoch A: ScanProsite: a reference implementation of a PROSITE scanning tool. Appl Bioinformatics. 2002, 1 (2): 107-108.

    CAS  PubMed  Google Scholar 

  42. Aronszajn N: Theory of Reproducing Kernels. Transactions of the American Mathematical Society. 1950, 68 (3): 337-404. 10.1090/S0002-9947-1950-0051437-7.

    Article  Google Scholar 

  43. Corinna C, Vapnik V: Support-Vector Networks. Machine Learning. 1995, 20:

    Google Scholar 

  44. Suykens JAK, Van Gestel T, De Brabanter J, De Moor B, Vandewalle J: Least Squares Support Vector Machines. World Scientific. 2002

    Google Scholar 

Download references

Acknowledgement and funding

We thank Prof. Steve Smale of City University of Hong Kong for valuable discussion, Alan Lai and Yan Wang of the University of Hong Kong for their critical comments.

This study was supported by grants (781511M, 778609M, N_HKU752/10) from the Research Grants Council of Hong Kong.

This article has been published as part of BMC Systems Biology Volume 6 Supplement 1, 2012: Selected articles from The 5th IEEE International Conference on Systems Biology (ISB 2011). The full contents of the supplement are available online at http://www.biomedcentral.com/bmcsystbiol/supplements/6/S1.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Junwen Wang.

Additional information

Competing interests

No relevant disclosures.

Authors' contributions

HKY collected the data, designed the pipeline, performed evaluations, statistical analysis and wrote the paper. QWX designed and tested the Neural Response algorithm. JW conceptualized the idea, designed the study and wrote the paper. All authors have read and approved the final manuscript.

Rights and permissions

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

Reprints and permissions

About this article

Cite this article

Yalamanchili, H.K., Xiao, QW. & Wang, J. A novel neural response algorithm for protein function prediction. BMC Syst Biol 6 (Suppl 1), S19 (2012). https://doi.org/10.1186/1752-0509-6-S1-S19

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1752-0509-6-S1-S19

Keywords