Skip to main content
Wiley Open Access Collection logoLink to Wiley Open Access Collection
. 2013 Feb;81(2):253–260. doi: 10.1002/prot.24181

Prediction of protein domain boundaries from inverse covariances

Michael I Sadowski 1,1
PMCID: PMC3563215  PMID: 22987736

Abstract

It has been known even since relatively few structures had been solved that longer protein chains often contain multiple domains, which may fold separately and play the role of reusable functional modules found in many contexts. In many structural biology tasks, in particular structure prediction, it is of great use to be able to identify domains within the structure and analyze these regions separately. However, when using sequence data alone this task has proven exceptionally difficult, with relatively little improvement over the naive method of choosing boundaries based on size distributions of observed domains. The recent significant improvement in contact prediction provides a new source of information for domain prediction. We test several methods for using this information including a kernel smoothing-based approach and methods based on building alpha-carbon models and compare performance with a length-based predictor, a homology search method and four published sequence-based predictors: DOMCUT, DomPRO, DLP-SVM, and SCOOBY-DOmain. We show that the kernel-smoothing method is significantly better than the other ab initio predictors when both single-domain and multidomain targets are considered and is not significantly different to the homology-based method. Considering only multidomain targets the kernel-smoothing method outperforms all of the published methods except DLP-SVM. The kernel smoothing method therefore represents a potentially useful improvement to ab initio domain prediction. Proteins 2013. © 2012 Wiley Periodicals, Inc.

Keywords: protein structure prediction, protein contact prediction, bioinformatics methods, domain parsing, Kernel density estimation, SCOOBY-DO, FT-COMAR, DomCUT, DOMPRO, DLP-SVM

INTRODUCTION

The organization of protein structures into discrete structural domains was observed when only a few structures had been solved. For example, the structures of chymotrypsin,1 trypsin,2 elastase,3 papain,4 lysozyme,5 lactate and malate dehydrogenase,6, 7 phosphoglycerate kinase,8 and thermolysin9 all showed multiple “continuous regions,” in the terminology of Wetlaufer's 1973 summary in which the notion of domains was first presented in a unified way.10

Since that point there have been many substantial advances in the analysis, delineation, and classification of protein domains using sequence (SMART11; PFam12) and structure (SCOP13; CATH14), with important insights into their functional promiscuity and evolution15, 16 as well as the folding of individual domains and multidomain proteins.17

Identification of structural domains from unannotated sequences is a problem of great importance in structural biology: NMR spectroscopy, crystallization, and biophysical analyses of proteins are made significantly more tractable if domains can be identified prior to expression. Computational analyses are also substantially improved after domain identification: iterated homology searches, for example, are considerably less prone to profile drift leading to inclusion of unrelated sequences and a lack of profile information when single domains are used as queries18 and many more computationally intensive methods (e.g. ab initio structure predictions) have high-order time complexity dependence on the length of the protein chain and are impractical for longer proteins.19, 20

Given the great interest in this problem there has, naturally, been substantial effort directed toward computational methods for domain identification. Principal sources of information which have been exploited are domain length distributions,21 information from sequence similarity searches,22 and hydrophobicity taken either from single sequences or sequence profiles.23, 24 The main conclusion which must be drawn from these studies is that domain prediction is extremely difficult, a conclusion also reached during the earlier CASP competitions, in which domain prediction was assessed as a separate category.25, 26 Consequently, the state of the art is not significantly advanced from the naive approach. One source of the difficulty is the ambiguity in domain parsing, as identified by comparison of structural domain classifications27 and discussed at length by Holland et al.28

Recently, the application of sparse inverse covariance matrices to contact prediction has led to a significant improvement in the accuracy of such predictions,29–34 raising the possibility of using such predictions as a source of information on possible domain boundaries, an earlier study of which was performed by Rigden.35 In this article, we explore a number of methods to exploit this new information and show that a simple kernel-smoothing predictor can provide accurate information of use in domain prediction with an improvement of between 8 and 20% over other ab initio predictors.

METHODS

Predicting domains from contact data

The use of predicted contacts for domain prediction gives us the advantage of being able to apply techniques previously developed for parsing domains from structures by reconstructing rough CA models using distance-geometry methods such as FT-COMAR.36 While a substantial number of such approaches have been developed37–43 our preliminary tests quickly found that most methods would not accept the rough models produced by FT-COMAR, while others were no longer available. Three approaches which required only alpha-carbon models were therefore tested: PDP,38 Taylor's dom method,39 and domain1.2,37 developed by the Sternberg group. These particular methods were the only three readily available methods which use only α-carbon features to determine domain cuts and which are therefore suitable for use with FT-COMAR models.

Each method has essentially two parameters: the size of contact list used to make a prediction (N above) and the contact distance, D, a parameter for FT-COMAR. Testing with real contact data demonstrated that high values of N were undesirable, as were high values of D. The explanation for this is that large numbers of (noisy) contacts produce models which are roughly spherical, leading to predictions of only single domains, while the D parameter needs to approximate the characteristic length scale expected by the domain parsers. For all methods values of 2000 for N and 8 for D were found to perform best (data not shown) and are used in the results presented here. Domain parsing methods were used with default settings. In the case of dom and domain1.2, which make multiple predictions, only the final prediction was used.

We also developed a faster method based on kernel density estimation (KDE). Following Rigden,35 we implemented a method for estimating the likely positions of domain boundaries based on contact density without constructing models. The premiss of the method is that there will be more predicted contacts for residues within the same domain than for residues in different domains, with noise being distributed at random intervals and intradomain contacts generally fewer in number than interdomain contacts. The method therefore assigns the probability of each residue position being within a domain by determining how many predicted contacts would be broken if the chain were to be split at that point. A smoothed PDF of the cut points is derived using Gaussian kernel density estimation44, 45 as follows: for each predicted contact we iterate over the residues between those in contact, placing a Gaussian with a particular standard deviation (the bandwidth parameter) centered on each residue. The cumulative density across the whole sequence is then summed and normalized to define a smoothed PDF representing the probability of disrupting a (predicted) contact if a domain boundary is predicted at that point. To make a prediction, local minima in the smoothed PDF are found by estimating the first derivative of the curve at each position using a window of 5 residues either side. Each minimum is then defined as a cut-point.

For all domain targets, the highest scoring 1000 predicted contacts (filtered to a minimum sequence distance of 5 residues) were used as inputs to the method. A variety of functions for setting the bandwidth parameter were tested using fixed values and linear, logarithmic, and fractional power functions of the sequence length with parameters as follows: L/n for values of n = 1, 5, 10, 15, 20, 30 for the linear estimator; logk (L) for k = 1–9 inclusive for the logarithmic function and L1/x for x = 2–9 inclusive. Fixed values of 1, 5, 10, 20, 30, 40, and 50 were tested. We also used the asymptotic mean square error (AMISE) optimal bandwidth calculated using the secant method. The KDE method was implemented in PERL, using the CPAN module Statistics::KernelEstimation–0.05 for kernel density estimation. Source code for all new methods is available for download from: mathbio.nimr.mrc.ac.uk/wiki/Software.

Domain prediction targets, contact predictions, and structural contact definition

We used data from two sources to test the methods. The 153-protein set defined by Holland et al.28 for testing domain parsers (we refer to this as “the Bourne set”) and the set of 221 targets from the CASP 7 and 8 experiments. For comparison purposes, we pooled the data into a set of 374 proteins, referred to as the “full dataset.”

Contact predictions were made as follows: the sequence of each chain in the set was used as a query to search Uniref100 using the jackhmmer method from the HMMer 3.0 package46 with three iterations, all other parameters default. Contact predictions were made using the ranked results of sparse inverse covariance matrix estimation with the graphical lasso.30, 47 Our implementation of this predictor was based on the PSICOV method30 with the minor difference that ρ parameters were set at 1 for diagonal elements, 0.001 otherwise.37 Briefly, the method works as follows: the alignment is used to derive a symmetric L× L × 21 × 21 matrix (L being the length of the target sequence) where each entry Inline graphic is defined as the covariance between amino acids i and j in the alignment columns corresponding to positions a and b in the sequence, gaps being treated as a 21st amino acid character. This has the following equation:

graphic file with name prot0081-0253-m1.jpg

The graphical lasso method47 is an efficient way of inverting this matrix, which is very large for long sequences. Finding the inverse has the effect of reducing the covariance signals to only those resulting from direct contacts between amino acids, removing a significant portion of the noise, and substantially improving contact prediction.30

Contacts were derived from real structures by finding a pseudo-Cβ based on the α-carbon coordinates as follows: for three consecutive Cαs C1, C2,C3 find the image B of C2 in the line C1–C3 and define the pseudo-Cβ as the point 2 Å from C2 along the line from B to C2.48 Inter-residue distances were defined as the distance between these pseudo-Cβ atoms for all residue types and contacts were defined for distances of ≤ 8 Å.

Other domain predictors

As comparison measures we implemented two alternative methods of domain prediction which have previously been shown to perform well: a naive predictor using only length information inspired by the DGS method21 and a homology search-based method which identified endpoints of alignments to CATH domain HMMs (v. 3.2)14 and used a simple smoothing protocol to derive predictions.

The naive predictor was a simple Bayesian method using KDE to determine PDFs for the probability of a chain having a particular length given that it has 1, 2, 3, or 4+ domains. This was then used to find P(N|L), N being the number of domains and L the chain length. For each value of N we found the length-independent probability of a domain boundary at each location in a sequence, all sequences being scaled to length 1000. Fractional parts of the profile were summed when making predictions (e.g. for a protein of length 100, the density for cell 0 would be the sum of cells 0–9 in the profile, cell 1 would be the sum of cells 10–19, etc.). The probability of each residue being a domain boundary was multiplied with the probability of the corresponding value of N to produce a final prediction. Cuts were then made wherever peaks were found in the profile using the estimated first derivative calculated as for the KDE method. The method was parameterized using domain length distributions and cut points derived from the CATH database (v3.2).14

The homology-based predictor used HMMER3.0 to search the CATH Gene3D HMM library (v 3.2). Endpoints of alignments were then assembled into a profile which was smoothed by repeated averaging. Domain boundaries were predicted based on the positions of local peaks within the endpoint profile, forbidding boundaries closer than 60 amino acids to one another or to the sequence termini. See Supporting Information for further details.

To further assess the performance of the methods, we compared them to four published domain boundary prediction methods: DOMCUT,49 DomPRO,50 DLP-SVM,51 and SCOOBY-Domain.25, 26 The DOMCUT and DVLP-SVM methods were accessed using the servers provided by the authors at http://www.bork.embl-heidelberg.de/Docu/mikita/domplot.cgi and http://www.tuat.ac.jp/∼domserv/cgi-bin/DLP-SVM.cgi, respectively. DLP-SVM predictions were taken from the SVM-ALL category of server results. DomPRO and SCOOBY-DOmain were run locally using default parameters. Full details of the methods can be found in Supporting Information.

Assessment of domain predictions and domain prediction methods

Following the assessment of domains in earlier CASP experiments, we used the normalized domain overlap (NDO) score to determine the accuracy of predictions.25 The score algorithm worked as follows: for each domain the relevant annotations were used to define domain segments labeled 1, 2, 3, etc., according to the positioning of their first residue. Each residue was labeled with its appropriate state. In the same fashion, predicted domain segments were given ordinal labels based on the location of the first residue of each segment. The NDO score is then simply

graphic file with name prot0081-0253-m2.jpg

where l is the number of labeled residues and Pi (Qi) is the label of the protein (prediction) at residue i. Scores were truncated at 0 to produce values in the interval [0–100]. Predicted linker elements were given no label and as such were ignored, thus l is equal to the length of the protein minus the number of unlabeled residues.

To avoid over-zealous penalties from label mismatches (i.e. where a short discontinuous segment occurred early in the chain) label matching was optimized using the stable marriage algorithm52 with preferences determined by the size of the overlap between each label type. Briefly, this algorithm seeks to find the best pairings for members of two sets given a matrix of preferences, therefore finding the optimal match between predicted domain labels and the annotated correct labeling. Thus in this case if a discontinuous domain is labeled as occupying position 1 and positions 100–200 and the correct answer has no discontinuities the large overlap between predicted domain 1 and actual domain 2 would lead to the labels being swapped. This prevents trivial mistakes from reducing the NDO score artificially since the labeling is arbitrary.

To determine whether the results were statistically robust, we performed all-v-all paired-samples Wilcoxon signed-rank tests. The rationale behind using a nonparametric test is that the underlying data do not fulfill the strict requirements for a t-test as the data are not normally distributed. 45 such tests were performed both on the full dataset and on the subset of multidomain proteins to separately assess the ability of the methods to make predictions in a realistic situation and to predict domain boundaries. The resulting p-values were corrected for multiple testing using the Bonferroni correction and significant differences were assessed using critical values for a two-tailed test at 5% significance after applying the multiple testing correction.

RESULTS

Optimizing bandwidth for KDE

The single parameter for the KDE method is the bandwidth used in the kernel density estimation step. For Gaussian kernels as used here this controls the standard deviation of the kernels used, σ, and therefore produces smoother profiles for larger values of σ. Consequently, low bandwidths produce undersmoothed PDFs which lead in many cases to overprediction while high bandwidths lead to oversmoothed PDFs and underprediction, favoring single-domain cases. Figure 1 depicts the predicted contact profile for a two-domain protein to show the effect of smoothing. Tests were performed using real contact data with pseudo-Cβ atoms and a threshold of 8Å with the Bourne set.

Figure 1.

Figure 1

Smoothing contact profiles with kernel density estimation. The predicted contact profile for protein 3TF4 is shown before (black line) and after (blue line) kernel density estimation smoothing with a bandwidth of 40. Red lines show the positions of the real and predicted domain boundaries. A PyMol53 ribbon diagram of the structure colored blue–red N–C is shown above the line.

Optimal bandwidths can be estimated from the data by minimizing the estimated asymptotic mean integrated square error (AMISE). The secant method was used for this purpose to provide initial values for testing. Observation of the profiles generated suggested that they were somewhat oversensitive to noisy predictions and generally resulted in overprediction of domain boundaries. We therefore tested the following functions of domain length as bandwidth parameters: fixed bandwidths (1, 5, 10, 20, 30, 40, 50), linear scaling (l/1, l/10, l/15, l/20, l/30, l/40, l/50), power scaling (l^1/2, l^1/3, l^1/4, l^1/5) and logarithmic scaling (bases 2, 3, 4, 5, 6, 7, 8, 9).

Fixed bandwidths led to the expected result that an increase in bandwidth produced fewer domain predictions and systematically favored the single-domain examples in the test set over the multidomain examples. We found a value of 5 represented a reasonable balance for the set in question but this still results in substantial overprediction (data not shown). Overall the best function was linear scaling which essentially defined the Pareto front for the method (the set of parameters for which no other parameters are better on both criteria), although square-root scaling was very close in performance to linear prediction with a length quotient of 15. Figure S1 (Supporting Information) plots the mean NDO scores for single vs. multidomain proteins for each threshold value, with the points on the Pareto front for the method labeled with parameter values. The best mean prediction was found for the l/15 choice. The kernel smoothing parameter was therefore chosen as l/15 for subsequent tests.

Performance with real contacts

We ran the four contact-based predictors on the Bourne set using the real contact data (see methods) anddetermined the overall prediction accuracy for the set as well as the comparative accuracy of single vs. multidomain proteins using the normalized domain overlap (NDO) measure, following the CASP assessments.25

Figure 2 shows the mean NDO scores for the contact-based methods using the top 2000 contacts derived from the structures with the pseudo-Cβ based contact method and setting the FT-COMAR threshold parameter to 12 Å (the top 1000 predicted contacts were used for the KDE method). This is a demonstration of the performance of each of the methods where the contact predictions to be perfectly accurate. On this set the Taylor method is clearly best, with the KDE-based method and Islam methods performing similarly. Examining only the performance on multidomain targets shows that the KDE method is almost identical to the Taylor method, showing that the slight improvement in performance is the result of an improvement on single-domain targets. Removing discontinuous domains (which the KDE method does not predict) improves the performance of the KDE method marginally with respect to the Taylor method but does not significantly change the result (data not shown).

Figure 2.

Figure 2

Domain prediction accuracy using real contacts. The three methods using 3D data (Taylor, domain1.2, PDP) and the kernel-smoothing method (KDE) are plotted.

Performance with predicted contacts

The four contact-based predictors were then run with predicted contact data from our implementation of the PSICOV method,33 otherwise in the same way as above, using the full dataset comprising CASP 7/8 targets and the Bourne sequences. For comparison we also ran the SCOOBY-DOmain method, the methods DOMCUT, DomPRO, and DLP-SVM, our homology-based predictor and the naive length-based predictor. Figure 3 shows the performance of the seven methods with predicted contacts rather than those taken from the structures. Taylor's dom method performs excellently for multidomain proteins; however, the noise in the predicted contacts leads to overprediction of the single-domain proteins. By contrast the KDE-based method performs extremely well for single-domain proteins with only marginally worse accuracy for multidomain boundaries. Both homology-based predictors are very accurate for multidomain boundaries but are less effective than the KDE method for single-domain proteins. The sequence-based predictor, SCOOBY-DOmain, performs poorly by comparison with these other methods, overpredicting on single-domain proteins with moderate performance for multidomain proteins. The naive predictor is only moderately worse for multidomain proteins while being substantially better for single-domain proteins. PDP does not work well with FT-COMAR models, performing worst of all the methods in this instance.

Figure 3.

Figure 3

Domain prediction accuracy. The 10 methods are compared based on the mean NDO scores for the single-domain and multidomain targets from the combined CASP and Bourne datasets. Error bars indicate standard errors.

To determine the significance of these differences we performed pairwise Wilcoxon signed-rank tests for paired data between each pair of methods. Tables I and II show the results of this on the full dataset (including both single-domain and multidomain proteins) and the subset of multidomain proteins, respectively. Significant differences were assessed at the 5% level for a two-tailed test after Bonferroni correction of the P-values (n = 45 tests). Tests which showed significant differences are highlighted in the tables in red and blue.

Table I.

Statistical Comparisons Between Methods

KDE WT ISLM PDP CUT PRO DLP SCO HOM DGS
KDE 8.49 6.00 15.0 8.49 10.5 19.8 17.0 0.00 0.00
WT 3e–03 0.00 5.22 0.00 0.00 14.8 9.20 0.00 0.00
ISLM 3e–06 1.00 9.05 0.00 0.00 13.8 11.1 0.00 0.00
PDP 1e–14 2e–08 3e–05 −6.55 −4.51 0.00 0.00 −9.08 −5.12
CUT 0.006 1.00 1.00 9e–05 0.00 11.3 8.50 0.00 0.00
PRO 2e–04 1.00 1.00 2e–03 1.00 9.27 0.00 0.00 0.00
DLP 3e–12 9e–06 3e–04 1.00 4e–04 0.04 0.00 −13.8 −9.94
SCO 2e–11 7e–05 0.03 1.00 4e–03 0.20 1.00 −11.2 −7.17
HOM 0.72 1.00 1.00 4e–07 1.00 1.00 1e–07 2e–07 0.00
DGS 1.00 1.00 1.00 1e–07 1.00 1.00 0.01 2e–04 1.00

NDO scores for all 368 targets were compared using paired Wilcoxon signed-rank tests. Entries below the diagonal show Bonferroni-corrected P-values for the test (N = 45 tests). Entries above the diagonal show the mean differences between the two groups, row – column. Cells representing significantly different methods (5% threshold) are colored red if the mean difference is positive, blue if negative. Key to methods: KDE: kernel smoothing, WT: DOM-parsing of preliminary structures, ISLM: Domain1.2 parsing of preliminary structures, PDP: PDP parsing of preliminary structures, CUT: DOMCUT, PRO: DomPRO, SCO: SCOOBY-DOmain, HOM: homology method, DGS: naive length-based predictor.

Table II.

Statistical Comparisons Between Methods

KDE WT ISLM PDP CUT PRO DLP SCO HOM DGS
KDE 0.00 0.00 22.1 13.7 16.0 0.00 12.4 0.00 19.7
WT 1.00 0.00 18.5 0.00 0.00 0.00 0.00 0.00 14.8
ISLM 1.00 1.00 16.8 0.00 10.7 0.00 0.00 0.00 14.7
PDP 5e–12 7e–07 3e–06 0.00 0.00 −16.9 0.00 −25.1 0.00
CUT 3e–03 1.00 0.540 0.07 0.00 0.00 0.00 −16.7 0.00
PRO 3e–06 0.09 8e–03 0.87 1.00 −10.9 0.00 −19.0 0.00
DLP 1.00 1.00 1.00 3e–06 0.14 0.03 0.00 0.00 14.8
SCO 0.03 1.00 1.00 0.06 1.00 1.00 0.12 −15.9 0.00
HOM 1.00 1.00 0.73 2e–11 2e–06 1e–04 0.43 2e–05 23.2
DGS 3e–07 4e–03 3e–04 1.00 1.00 1.00 2e–04 1.00 2e–09

NDO scores for the 165 multidomain targets were compared using paired Wilcoxon signed-rank tests. Entries below the diagonal show Bonferroni-corrected P-values for the test (N = 45 tests). Entries above the diagonal show the mean differences between the two groups, row – column. Cells representing significantly different methods (5% threshold) are colored red if the mean difference is positive, blue if negative. Key to methods: KDE: kernel smoothing, WT: DOM-parsing of preliminary structures, ISLM: Domain1.2 parsing of preliminary structures, PDP: PDP parsing of preliminary structures, CUT: DOMCUT, PRO: DomPRO, SCO: SCOOBY-DOmain, HOM: homology method, DGS: naive length-based predictor.

From these results, it can be seen that the KDE method is significantly better than all of the other methods except the naive and homology-based predictors when the full dataset is considered. The mean differences range between 6 and 19.8 increases in NDO scores across all methods, 8.49 and 19.8 when compared to the other four published predictors. Using PDP to parse domains is inferior to seven of the nine other methods, suggesting that it is not an appropriate method to use with FT-COMAR's rough models.

Although it is important not to overpredict domain boundaries, requiring the incorporation of single-domain proteins in the dataset, by assessing results using all data we are implicitly assuming a given distribution of single-domain vs. multidomain proteins. The actual distribution might depend on the context of the predictions – Eukaryotes and Prokaryotes, for example, tend to have different distributions of multidomain proteins. Therefore, it is important to assess the quality of predictions on multidomain proteins only, effectively assessing the probability of correctly predicting domain boundaries given that the protein is multidomain.

Table II shows that when we consider only multidomain proteins a slightly different picture emerges: the KDE method is significantly better than the DOMCUT, DomPRO, and SCOOBY methods but no longer provides a significant improvement over the DLP-SVM method. Differences in performance between KDE, DOM, and Domain1.2 are also no longer significant while there is a very large difference between the better methods (KDE, Taylor, Islam, Homology) and the naive DGS predictor which uses only length information. The ability of this method to make good predictions across the whole dataset is therefore attributable almost entirely to its tendency to predict single-domain proteins accurately. DLP-SVM is shown here to be reasonably accurate given only multidomain proteins but tends to substantially overpredict.

Since FT-COMAR can generate multiple models from a single input we tested two methods for deriving a consensus prediction using an ensemble of models to determine whether this could improve domain prediction. We found that re-estimating contacts from an ensemble of models produced a promising increase in contact prediction performance (Supporting Information Fig. S2) but that this did not generally improve domain prediction accuracy (Supporting Information).

DISCUSSION

Prediction of domain boundaries from sequence remains extremely challenging. Where a known structure for a domain exists and can be aligned to the query sequence predictions can often be quite accurate, as demonstrated by our results and those of others. However, this relies on both the existence and the detection of the known structure and where this is not possible such methods will fail.

We have shown that using the new, more accurate contact predictions derived from inverse covariance analysis can produce domain boundary predictions which are equivalent to or slightly better than those produced by the template-based method and represent a substantial improvement over the four ab initio predictors tested here, providing similar performance to the use of homologous templates. This therefore represents an improvement to the state of the art in ab initio domain prediction which will be useful in supplementing the template-based approach.

There remain two areas in which the kernel smoothing method could be improved: first it takes no account of discontinuous domains, which often result in inaccurate predictions. Using the structural domain parsers, which already account for this feature of domains, is one way in which this could be mitigated although our analysis suggests that in fact the level of accuracy on discontinuous domains is similar (data not shown). Regardless of this an improved model which accounts for this might prove very useful in improving accuracy. Second the method is not always successful for domains which are not fully compact, e.g. barrel structures, which are frequently split in two. Although from an evolutionary point of view the existence of half-barrels might suggest that this is not entirely an inaccurate prediction from the point of view of predicting structure it is undesirable to split barrels up. Improvements to the model could also be made to account for this.

Finally the gap between the performance of all methods with real and predicted contacts strongly suggests that further improvements to the contact prediction method would be an important source of increased accuracy in domain prediction.

Acknowledgments

The author would like to thank Richard Goldstein for useful discussions and Willie Taylor, Grant Thiltgen, and Michael Doran for useful discussions and helpful comments on the manuscript. Finally he thanks the anonymous referees for their valuable criticisms which have helped to significantly improve the paper.

Additional Supporting Information may be found in the online version of this article.

prot0081-0253-sd1.pdf (42.2KB, pdf)

REFERENCES

  • 1.Blow D. In: The enzymes. 3rd ed. Boyer PD, editor. Vol. 3. New York: Academic Press; 1971. pp. 185–212. [Google Scholar]
  • 2.Hartley BS, Shotton DM. In: The enzymes. 3rd ed. Boyer PD, editor. Vol. 3. New York: Academic Press; 1971. pp. 323–373. [Google Scholar]
  • 3.Kraut J. In: The enzymes. 3rd ed. Boyer PD, editor. Vol. 3. New York: Academic Press; 1971. pp. 547–560. [Google Scholar]
  • 4.Drenth J, Jansonius JN, Koekoek R, Wolthers BG. In: The enzymes. 3rd ed. Boyer PD, editor. Vol. 3. New York: Academic Press; 1971. pp. 485–499. [Google Scholar]
  • 5.Phillips DC. The hen egg-white lysozyme molecule. PNAS. 1967;57:484–495. doi: 10.1098/rspb.1967.0034. [DOI] [PubMed] [Google Scholar]
  • 6.Rossman MG, Adams MJ, Buehner GC, Hackert ML, Lentz PJ, McPherson A, Jr, Schevitz RW, Smiley IE. Cold Spring Harbor Symp Quant Biol. 1972;36:179–191. doi: 10.1101/sqb.1972.036.01.025. [DOI] [PubMed] [Google Scholar]
  • 7.Hill E, Tsernoglou D, Webb L, Banaszak LJ. Polypeptide conformation of cytoplasmic malate dehydrogenase from an electron density map at 3.0 angstrom resolution. J Mol Biol. 1972;72:577–589. doi: 10.1016/0022-2836(72)90176-3. [DOI] [PubMed] [Google Scholar]
  • 8.Blake CCF, Evans PR, Scopes RK. Phosphoglycerate kinase. Nat New Biol. 1972;235:195–198. doi: 10.1038/newbio235195a0. [DOI] [PubMed] [Google Scholar]
  • 9.Matthews BW, Jansonius JN, Colmar PM, Shoenborn BP, Dupourque D. Three-dimensional structure of thermolysin. Nat New Biol. 1972;238:37–41. doi: 10.1038/newbio238037a0. [DOI] [PubMed] [Google Scholar]
  • 10.Wetlaufer DB. Nucleation, rapid folding, and globular intrachain regions in proteins. PNAS. 1973;70:697–701. doi: 10.1073/pnas.70.3.697. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11.Letunic I, Doerks T, Bork P. SMART 7: recent updates to the protein domain annotation resource. Nucl Acids Res. 2012;40:D302–305. doi: 10.1093/nar/gkr931. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 12.Punta M, Coggill PC, Eberhardt RY, Mistry J, Tate J, Boursnell C, Pang N, Forslund K, Ceric G, Clements J, Heger A, Holm L, Sonnhammer ELL, Eddy SR, Bateman A, Finn RD. The Pfam protein families database: Nucl Acids Res. 2012;40:D290–D301. doi: 10.1093/nar/gkr1065. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13.Andreeva A, Howorth D, Chandonia JM, Brenner SE, Hubbard TJP, Chothia C, Murzin AG. Data growth and its impact on the SCOP database: new developments. Nucl Acids Res. 2008;36:D419–425. doi: 10.1093/nar/gkm993. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 14.Cuff AL, Sillitoe I, Lewis T, Redfern OC, Garratt R, Thornton J, Orengo CA. The CATH Classification revisited – architectures reviewed and new ways to characterize structural divergence in superfamilies. Nucl Acids Res. 2009;38:D310–314. doi: 10.1093/nar/gkn877. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.Apic G, Gough J, Teichmann SA. Domain combinations in archaeal, eubacterial and eukaryotic proteomes. J Mol Biol. 2001;310:311–25. doi: 10.1006/jmbi.2001.4776. [DOI] [PubMed] [Google Scholar]
  • 16.Dessailly BH, Redfern OC, Cuff A, Orengo CA. Exploiting structural classifications for function prediction: towards a domain grammar for protein function. Curr Opin Struct Biol. 2009;19:346–356. doi: 10.1016/j.sbi.2009.03.009. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 17.Han J-H, Batey S, Nickson AD, Teichmann SA, Clarke J. The folding and evolution of multidomain proteins. Nat Rev Mol Cell Biol. 2007;8:319–330. doi: 10.1038/nrm2144. [DOI] [PubMed] [Google Scholar]
  • 18.Jones DT, Swindells MB. Getting the most from PSI-BLAST TiBS. 2002;27:161–164. doi: 10.1016/s0968-0004(01)02039-4. [DOI] [PubMed] [Google Scholar]
  • 19.Taylor WR, Bartlett GJ, Chelliah V, Klose D, Lin K, Sheldon T, Jonassen I. Prediction of protein structure from ideal forms. Proteins. 2008;70:1610–1619. doi: 10.1002/prot.21913. [DOI] [PubMed] [Google Scholar]
  • 20.Jones DT, McGuffin LJ. Assembling novel protein folds from super-secondary structural fragments. Proteins. 2002;53:S480–S485. doi: 10.1002/prot.10542. [DOI] [PubMed] [Google Scholar]
  • 21.Wheelan SJ, Marchler-Bauer A, Bryant SH. Domain size distributions can predict domain boundaries. Bioinformatics. 2002;16:613–61821. doi: 10.1093/bioinformatics/16.7.613. [DOI] [PubMed] [Google Scholar]
  • 22.Marsden RL, McGuffin LJ, Jones DT. Rapid protein domain assignment from amino acid sequence using predicted secondary structure. Prot Sci. 2002;11:2814–282422. doi: 10.1110/ps.0209902. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23.George RA, Lin K, Heringa J. Scooby-domain: prediction of globular domains in protein sequence. Nucl Acids Res. 2005;33:W160–W163. doi: 10.1093/nar/gki381. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 24.Pang CNI, Lin K, Wouters MA, Heringa J, George RA. Identifying foldable regions in protein sequence from the hydrophobic signal. Nucl Acids Res. 2008;36:578–588. doi: 10.1093/nar/gkm1070. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25.Tai C-H, Lee W-J, Vincent JJ, Lee B. Evaluation of domain prediction in CASP6. Proteins. 2005;61:183–192. doi: 10.1002/prot.20736. [DOI] [PubMed] [Google Scholar]
  • 26.Ezkurdia I, Grana O, Izarzugaza JMG, Tress ML. Assessment of domain boundary predictions and the prediction of intramolecular contacts in CASP8. Proteins. 2009;77:196–209. doi: 10.1002/prot.22554. [DOI] [PubMed] [Google Scholar]
  • 27.Hadley C, Jones DT. A systematic comparison of protein structure classifications: SCOP, CATH and FSSP. Structure. 1999;15:1099–1112. doi: 10.1016/s0969-2126(99)80177-4. [DOI] [PubMed] [Google Scholar]
  • 28.Holland TA, Veretnik S, Shindyalov IN, Bourne PE. Partitioning protein structures into domains: why is it so difficult? J Mol Biol. 2006;361:562–590. doi: 10.1016/j.jmb.2006.05.060. [DOI] [PubMed] [Google Scholar]
  • 29.Weigt M, White RA, Szurmant H, Hoch JA, Hwa T. Identification of direct residue contacts in protein-protein interaction by message passing. PNAS. 2009;106:67–72. doi: 10.1073/pnas.0805923106. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30.Jones DT, Buchan DWA, Cozzetto D, Pontil M. PSICOV: precise structural contact prediction using sparse inverse covariance estimation large multiple sequence alignments. Bioinformatics. 2012;28:184–190. doi: 10.1093/bioinformatics/btr638. [DOI] [PubMed] [Google Scholar]
  • 31.Sadowski MI, Maksimiak K, Taylor WR. Direct correlation analysis improves fold recognition. Comp Biol Chem. 2001;35:323–332. doi: 10.1016/j.compbiolchem.2011.08.002. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 32.Taylor WR, Sadowski MI. Structural constraints on the covariance matrix derived from multiple aligned protein sequences. PLoS One. 2011;6:e28265. doi: 10.1371/journal.pone.0028265. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33.Taylor WR, Jones DT, Sadowski MI. Protein topology from predicted contacts. Prot Sci. 2012;21:299–305. doi: 10.1002/pro.2002. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 34.Marks DS, Colwell LJ, Sheridan R, Hopf TA, Pagnani A, Zecchina R, Sander C. Protein 3D structure computed from evolutionary sequence variation. PLoS One. 2011;6:e28766. doi: 10.1371/journal.pone.0028766. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 35.Rigden DJ. Use of covariance analysis for the prediction of structural domain boundaries from multiple protein sequence alignments. Prot Eng. 2002;15:65–77. doi: 10.1093/protein/15.2.65. [DOI] [PubMed] [Google Scholar]
  • 36.Vassura M, Margara L, Di Lena P, Medri F, Fariselli P, Casadio R. Reconstruction of 3D structures from protein contact maps. Springer Verlag Lecture Notes in Bioinformatics. 2007;4645:25–37. doi: 10.1109/TCBB.2008.27. [DOI] [PubMed] [Google Scholar]
  • 37.Alexandrov N, Shindyalov I. PDP: protein domain parser. Bioinformatics. 2003;19:429–430. doi: 10.1093/bioinformatics/btg006. [DOI] [PubMed] [Google Scholar]
  • 38.Taylor WR. Protein structural domain identification. Prot Eng. 1999;12:203–216. doi: 10.1093/protein/12.3.203. [DOI] [PubMed] [Google Scholar]
  • 39.Islam SA, Luo JC, Sternberg MJE. Identification and analysis of domains in proteins. Prot Eng. 1995;8:513–525. doi: 10.1093/protein/8.6.513. [DOI] [PubMed] [Google Scholar]
  • 40.Xu Y, Xu D, Gabow HN. Protein domain decomposition using a graph-theoretic approach. Bioinformatics. 2000;16:1091–1104. doi: 10.1093/bioinformatics/16.12.1091. [DOI] [PubMed] [Google Scholar]
  • 41.Tai C-H, Sam V, Gibrat JF, Garnier J, Munson PJ, Lee B. Protein domain assignment from the recurrence of locally similar structures. Proteins. 2011;79:853–866. doi: 10.1002/prot.22923. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 42.Holm L, Sander C. Parser for protein folding units. Proteins. 1994;19:256–268. doi: 10.1002/prot.340190309. [DOI] [PubMed] [Google Scholar]
  • 43.Zhou H, Xue B, Zhou Y. DDOMAIN: dividing structures into domains using a normalized domain-domain interaction profile. Prot Sci. 2007;16:947–955. doi: 10.1110/ps.062597307. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 44.Rosenblatt M. Remarks on some nonparametric estimates of a density function. Ann Math Stat. 1956;27:832–837. [Google Scholar]
  • 45.Parzen E. On estimation of a probability density function and mode. Ann Math Stat. 1962;33:1065–1076. [Google Scholar]
  • 46.Eddy SR. A new generation of homology search tools based on probabilistic inference. Intl Conf Genome Informatics. 2009;23:205–211. [PubMed] [Google Scholar]
  • 47.Friedman J, Hastie T, Tibshirani R. Sparse inverse covariance estimation with the graphical lasso. Biostatistics. 2008;9:432–441. doi: 10.1093/biostatistics/kxm045. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 48.Taylor WR. Multiple sequence threading: an analysis of alignment quality and stability. J Mol Biol. 1997;269:902–943. doi: 10.1006/jmbi.1997.1008. [DOI] [PubMed] [Google Scholar]
  • 49.Suyama M, Ohara O. DomCut: prediction of inter-domain linker regions in amino acid sequences. Bioinformatics. 2003;19:673–674. doi: 10.1093/bioinformatics/btg031. [DOI] [PubMed] [Google Scholar]
  • 50.Cheng J, Sweredoski M, Baldi P. DOMpro: Protein domain prediction using profiles, secondary structure, relative solvent accessibility, and recursive neural networks. Data Mining Knowl Discov. 2006;3:1–10. [Google Scholar]
  • 51.Ebina T, Toh H, Kuroda Y. Loop-length dependent SVM prediction of domain linkers for high-throughput structural proteomics. Biopolymers. 2009;92:1–8. doi: 10.1002/bip.21105. [DOI] [PubMed] [Google Scholar]
  • 52.Gale D, Shapley LS. College admissions and the stability of marriage. Am Math Mon. 1962;69:9–15. [Google Scholar]
  • 53.Schrodinger, LLC . The PyMOL Molecular Graphics System, Version 1.5.0. [Google Scholar]

Associated Data

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

Supplementary Materials

prot0081-0253-sd1.pdf (42.2KB, pdf)

Articles from Proteins are provided here courtesy of Wiley

RESOURCES