STRUCTFAST: Protein Sequence Remote Homology Detection and Alignment Using Novel Dynamic Programming and Profile-Profile Scoring

Total Page:16

File Type:pdf, Size:1020Kb

STRUCTFAST: Protein Sequence Remote Homology Detection and Alignment Using Novel Dynamic Programming and Profile-Profile Scoring PROTEINS: Structure, Function, and Bioinformatics 64:960–967 (2006) STRUCTFAST: Protein Sequence Remote Homology Detection and Alignment Using Novel Dynamic Programming and Profile–Profile Scoring Derek A. Debe,1 Joseph F. Danzer,1 William A. Goddard,2 and Aleksandar Poleksic3* 1Eidogen-Sertanty Inc., San Diego, California 92121 2Materials and Process Simulation Center, California Institute of Technology, Pasadena, California 91106 3Department of Computer Science, University of Northern Iowa, Cedar Falls, Iowa 50614 ABSTRACT STRUCTFAST is a novel profile— probabilistic model (HMM) in place of a position specific profile alignment algorithm capable of detecting score matrix. weak similarities between protein sequences. The The new generation of profile–profile alignment meth- increased sensitivity and accuracy of the STRUCT- ods utilizes multiple sequence alignment profiles in place FAST method are achieved through several unique of the query and template sequence.5,6 Profile–profile features. First, the algorithm utilizes a novel dy- algorithms enjoy additional enhancements in sensitivity, namic programming engine capable of incorporat- often recognizing sequences that share less than 15% ing important information from a structural family identity, as evidenced by large-scale benchmarking experi- directly into the alignment process. Second, the ments such as LiveBench,7 CAFASP,8 and CASP.9–11 algorithm employs a rigorous analytical formula for Despite the success of profile–profile approaches, many profile–profile scoring to overcome the limitations aspects of their development remain ad hoc. For example, of ad hoc scoring functions that require adjustable most of the existing profile–profile algorithms fail to parameter training. Third, the algorithm employs provide a rigorous, probabilistic treatment for the column– Convergent Island Statistics (CIS) to compute the column matching (as opposed to sequence–profile methods statistical significance of alignment scores indepen- such as PSI-BLAST and HMMER, where the residue- dently for each pair of sequences. STRUCTFAST column scores are treated as log-odd scores). The lack of a routinely produces alignments that meet or exceed rigorous framework is universally true for profile–profile the quality obtained by an expert human homology methods that incorporate other terms in the scoring func- modeler, as evidenced by its performance in the tion, such as position specific gap penalties and secondary latest CAFASP4 and CASP6 blind prediction bench- structure information. To work well across the protein mark experiments. Proteins 2006;64:960–967. universe, these methods implement various ad hoc adjust- © 2006 Wiley-Liss, Inc. ments when scoring pairs of profiles, such as the normaliza- tion of the score matrix and score shifts.5,6,12 This natu- Key words: protein structure; homology modeling; rally introduces a performance bias toward the test sets comparative modeling; alignment algo- used during parameter adjustment. rithms; alignment statistics Estimating alignment score significance in profile– profile methods is also a challenging task. A rigorous INTRODUCTION measure of protein sequence similarity should reflect the There are many different techniques for comparing and difference between the quality of the best alignment of the aligning protein sequences. Over the years, dynamic pro- two sequences and the quality of the best alignment gramming algorithms have dominated the field of protein between random sequences of the same lengths and compo- sequence comparison. The widely applied BLAST1 and sitions. For ungapped local sequence–sequence align- 2 FASTA algorithms utilize dynamic programming in con- ments in the asymptotic limit of long sequences, it is well junction with a sequence–sequence scoring function that established that the alignment scores follow an extreme evaluates the similarities between the amino acids of the value distribution described by two parameters ␭ and query and template sequence. The well-known PSI- K.13,14 For profile-based algorithms, with or without gaps, 3 BLAST algorithm is an example of a sequence–profile it has been conjectured that the score distribution is still of method that replaces the query sequence with a profile of the Gumbel form. PSI-BLAST rescales the position specific sequences from the query protein family. PSI-BLAST iteratively collects sequences from a sequence database to build a position-specific scoring matrix (PSSM). The PSSM *Correspondence to: Aleksandar Poleksic, Department of Computer Science, University of Northern Iowa, Cedar Falls, IA 50614. E-mail: is then used to search the sequence database for new [email protected] homologs, which are used to construct a new position Received 8 February 2006; Revised 15 March 2006; Accepted 15 specific score matrix. This process is repeated until no new March 2006 sequences are found. The hidden Markov model-based Published online 19 June 2006 in Wiley InterScience approaches, such as SAMT024 or HMMER use an explicit (www.interscience.wiley.com). DOI: 10.1002/prot.21049 © 2006 WILEY-LISS, INC. STRUCTFAST 961 scoring matrix (PSSM) so that the scale of the raw scores input to PSI-BLAST is a multiple alignment consisting of corresponds to that of the standard substitution matrix. the PDB structures in the template’s Dali structural The assumption is that the random PSI-BLAST alignment alignment.17 This is a standard technique often used to scores, obtained by using a rescaled PSSM, will follow the increase the sensitivity of the database search. Extreme Value Distribution of gapped sequence–sequence alignment scores. Thus, PSI-BLAST is able to quickly and Profile–Profile Scoring Function precisely estimate the score statistics, without further In PSI-BLAST, the score for aligning residue R to profile random simulations. Due to the increased algorithm com- column C is equivalent to plexity, score normalization in profile–profile methods is a much more challenging problem. This is particularly true Pc͑R͒ for algorithms that incorporate various constraints into s͑C,R͒ ϭ log , (1) PB͑R͒ the alignment process, such as secondary structure or complex gap treatments. For this reason, some profile– where PC(R) is the probability of observing letter R in profile alignment methods use Z-score statistics to mea- column C (e.g., its target frequency) and PB(R)isthe sure the alignment score significance.5,12 COMPASS15 overall probability of the residue R (background fre- provides a nice, PSI-BLAST-like statistical approach to quency). A physical analogy of this scoring scheme consists computing E-values. However, the applications of this of throwing weighted 20-sided dice. PC(R) is the probabil- technique are limited to the specific scoring system used in ity of rolling R on the die C, where the area of each of the the COMPASS algorithm. sides on die C is proportional to the frequencies of each In this article we introduce STRUCTFAST (STructure amino acid in the template profile. PB(R) is the probability Realization Utilizing Cogent Tips From Aligned Struc- of rolling R on the “background die” B, where the area of tural Templates), a novel, fully automated, profile–profile each of sides on this die are proportional to the background database search algorithm. The query sequence profiles in amino acid frequencies. STRUCTFAST are generated with a modified version of The same approach and analogy can be applied to the PSI-BLAST algorithm. A database of profiles for profile–profile scoring.15 For profile–profile scoring, in- template representatives from the Protein Data Bank stead of computing the probability of a single event (PDB) are generated in a similar manner, but are aug- (corresponding to a single residue R), we need to compute mented with information from structure–structure align- the probability of a series of events (corresponding to the ments derived from the template protein’s structural second profile column C2). Thus, in the context of profile– family. A query profile is then aligned and scored against profile scoring, Equation (1) has the following form: the library of structural profile templates and the align- ͑ ͒ ments are ranked by the significance of their scores, as PC1 C2 s͑C1,C2͒ ϭ log (2) determined by the previously published Convergent Is- PB͑C2͒ land Statistics method.16 A standard manipulation can be employed to make MATERIALS AND METHODS scoring function 2 symmetric with respect to C1 and C2: Profile Construction score͑C1,C2͒ ϭ s͑C1,C2͒ ϩ s͑C2,C1͒ (3) STRUCTFAST uses an internally modified version of PSI-BLAST to compare a protein sequence of interest The COMPASS algorithm implements a variant of Equa- against the NCBI’s nonredundant nr database. After 10 tion (3) along with fixed gap penalties. In COMPASS, the PSI-BLAST iterations, the algorithm parses the check- contribution of each score s(C1,C2) and s(C2,C1) is weighted point file to obtain the probabilities (target frequencies) pi, and the weights are optimized by running the algorithm on where i ϭ 1,2, . .20 for the 20 different amino acids at large validation sets. each sequence position. In addition, our version of PSI- The STRUCTFAST scoring scheme employs a direct, BLAST reports, for each sequence position, weighted nonweighted calculation of Equation (3). STRUCTFAST ϭ frequencies rk, where k 1,2 . 20 for the 20 different scores depend not only on the similarity between the amino acids (these are called “observed residue frequen- profile columns, but also on the “amount of confidence” cies fk” in PSI-BLAST) as well as the mean number of (called “thickness” in the
Recommended publications
  • The Second Critical Assessment of Fully Automated Structure
    PROTEINS:Structure,Function,andGeneticsSuppl5:171–183(2001) DOI10.1002/prot.10036 CAFASP2:TheSecondCriticalAssessmentofFully AutomatedStructurePredictionMethods DanielFischer,1* ArneElofsson,2 LeszekRychlewski,3 FlorencioPazos,4† AlfonsoValencia,4† BurkhardRost,5 AngelR.Ortiz,6 andRolandL.Dunbrack,Jr.7 1Bioinformatics,DepartmentofComputerScience,BenGurionUniversity,Beer-Sheva,Israel 2StockholmmBioinformaticsCenter,StockholmUniversity,Stockholm,Sweden 3BioInfoBankInstitute,Poznan,Poland 4ProteinDesignGroup,CNB-CSIC,Cantoblanco,Madrid,Spain 5CUBIC,DepartmentofBiochemistryandMolecularBiophysics,ColumbiaUniversity,NewYork,NewYork 6DepartmentofPhysiologyandBiophysics,MountSinaiSchoolofMedicineoftheNewYorkUniversity,NewYork,NewYork 7InstituteforCancerResearch,FoxChaseCancerCenter,Philadelphia,Pennsylvania ABSTRACT TheresultsofthesecondCritical predictors.Weconcludethatasserverscontinueto AssessmentofFullyAutomatedStructurePredic- improve,theywillbecomeincreasinglyimportant tion(CAFASP2)arepresented.ThegoalsofCAFASP inanypredictionprocess,especiallywhendealing areto(i)assesstheperformanceoffullyautomatic withgenome-scalepredictiontasks.Weexpectthat webserversforstructureprediction,byusingthe inthenearfuture,theperformancedifferencebe- sameblindpredictiontargetsasthoseusedat tweenhumansandmachineswillcontinuetonar- CASP4,(ii)informthecommunityofusersaboutthe rowandthatfullyautomatedstructureprediction capabilitiesoftheservers,(iii)allowhumangroups willbecomeaneffectivecompanionandcomple- participatinginCASPtouseandanalyzetheresults menttoexperimentalstructuralgenomics.Proteins
    [Show full text]
  • CASP)-Round V
    PROTEINS: Structure, Function, and Genetics 53:334–339 (2003) Critical Assessment of Methods of Protein Structure Prediction (CASP)-Round V John Moult,1 Krzysztof Fidelis,2 Adam Zemla,2 and Tim Hubbard3 1Center for Advanced Research in Biotechnology, University of Maryland Biotechnology Institute, Rockville, Maryland 2Biology and Biotechnology Research Program, Lawrence Livermore National Laboratory, Livermore, California 3Sanger Institute, Wellcome Trust Genome Campus, Cambridgeshire, United Kingdom ABSTRACT This article provides an introduc- The role and importance of automated servers in the tion to the special issue of the journal Proteins structure prediction field continue to grow. Another main dedicated to the fifth CASP experiment to assess the section of the issue deals with this topic. The first of these state of the art in protein structure prediction. The articles describes the CAFASP3 experiment. The goal of article describes the conduct, the categories of pre- CAFASP is to assess the state of the art in automatic diction, and the evaluation and assessment proce- methods of structure prediction.16 Whereas CASP allows dures of the experiment. A brief summary of progress any combination of computational and human methods, over the five CASP experiments is provided. Related CAFASP captures predictions directly from fully auto- developments in the field are also described. Proteins matic servers. CAFASP makes use of the CASP target 2003;53:334–339. © 2003 Wiley-Liss, Inc. distribution and prediction collection infrastructure, but is otherwise independent. The results of the CAFASP3 experi- Key words: protein structure prediction; communi- ment were also evaluated by the CASP assessors, provid- tywide experiment; CASP ing a comparison of fully automatic and hybrid methods.
    [Show full text]
  • Jakub Paś Application and Implementation of Probabilistic
    Jakub Paś Application and implementation of probabilistic profile-profile comparison methods for protein fold recognition (pol.: Wdrożenie i zastosowania probabilistycznych metod porównawczych profil-profil w rozpoznawaniu pofałdowania białek) Rozprawa doktorska ma formę spójnego tematycznie zbioru artykułów opublikowanych w czasopismach naukowych* Wydział Chemii, Uniwersytet im. Adama Mickiewicza w Poznaniu Promotor: dr hab. Marcin Hoffmann, prof. UAM Promotor pomocniczy: dr Krystian Eitner * Ustawa o stopniach naukowych i tytule naukowym oraz o stopniach i tytule w zakresie sztuki Dz.U.2003.65.595 - Ustawa z dnia 14 marca 2003 r. o stopniach naukowych i tytule naukowym oraz o stopniach i tytule w zakresie sztuki Art 13 1. Rozprawa doktorska, przygotowywana pod opieką promotora albo pod opieką promotora i promotora pomocniczego, o którym mowa w art. 20 ust. 7, powinna stanowić oryginalne rozwiązanie problemu naukowego lub oryginalne dokonanie artystyczne oraz wykazywać ogólną wiedzę teoretyczną kandydata w danej dyscyplinie naukowej lub artystycznej oraz umiejętność samodzielnego prowadzenia pracy naukowej lub artystycznej. 2. Rozprawa doktorska może mieć formę maszynopisu książki, książki wydanej lub spójnego tematycznie zbioru rozdziałów w książkach wydanych, spójnego tematycznie zbioru artykułów opublikowanych lub przyjętych do druku w czasopismach naukowych, określonych przez ministra właściwego do spraw nauki na podstawie przepisów dotyczących finansowania nauki, jeżeli odpowiada warunkom określonym w ust. 1. 3. Rozprawę doktorską może stanowić praca projektowa, konstrukcyjna, technologiczna lub artystyczna, jeżeli odpowiada warunkom określonym w ust. 1. 4. Rozprawę doktorską może także stanowić samodzielna i wyodrębniona część pracy zbiorowej, jeżeli wykazuje ona indywidualny wkład kandydata przy opracowywaniu koncepcji, wykonywaniu części eksperymentalnej, opracowaniu i interpretacji wyników tej pracy, odpowiadający warunkom określonym w ust. 1. 5.
    [Show full text]
  • April 11, 2003 1:34 WSPC/185-JBCB 00018 RAPTOR: OPTIMAL PROTEIN THREADING by LINEAR PROGRAMMING
    April 11, 2003 1:34 WSPC/185-JBCB 00018 Journal of Bioinformatics and Computational Biology Vol. 1, No. 1 (2003) 95{117 c Imperial College Press RAPTOR: OPTIMAL PROTEIN THREADING BY LINEAR PROGRAMMING JINBO XU∗ and MING LIy Department of Computer Science, University of Waterloo, Waterloo, Ont. N2L 3G1, Canada ∗[email protected] [email protected] DONGSUP KIMz and YING XUx Protein Informatics Group, Life Science Division and Computer Sciences and Mathematics Division, Oak Ridge National Lab, Oak Ridge, TN 37831, USA [email protected] [email protected] Received 22 January 2003 Revised 7 March 2003 Accepted 7 March 2003 This paper presents a novel linear programming approach to do protein 3-dimensional (3D) structure prediction via threading. Based on the contact map graph of the protein 3D structure template, the protein threading problem is formulated as a large scale inte- ger programming (IP) problem. The IP formulation is then relaxed to a linear program- ming (LP) problem, and then solved by the canonical branch-and-bound method. The final solution is globally optimal with respect to energy functions. In particular, our en- ergy function includes pairwise interaction preferences and allowing variable gaps which are two key factors in making the protein threading problem NP-hard. A surprising result is that, most of the time, the relaxed linear programs generate integral solutions directly. Our algorithm has been implemented as a software package RAPTOR{RApid Protein Threading by Operation Research technique. Large scale benchmark test for fold recogni- tion shows that RAPTOR significantly outperforms other programs at the fold similarity level.
    [Show full text]
  • Comparative Protein Structure Modeling Using Modeller 5.6.2
    Comparative Protein Structure Modeling UNIT 5.6 Using Modeller Functional characterization of a protein sequence is one of the most frequent problems in biology. This task is usually facilitated by an accurate three-dimensional (3-D) structure of the studied protein. In the absence of an experimentally determined structure, comparative or homology modeling often provides a useful 3-D model for a protein that is related to at least one known protein structure (Marti-Renom et al., 2000; Fiser, 2004; Misura and Baker, 2005; Petrey and Honig, 2005; Misura et al., 2006). Comparative modeling predicts the 3-D structure of a given protein sequence (target) based primarily on its alignment to one or more proteins of known structure (templates). Comparative modeling consists of four main steps (Marti-Renom et al., 2000; Figure 5.6.1): (i) fold assignment, which identifies similarity between the target and at least one Figure 5.6.1 Steps in comparative protein structure modeling. See text for details. For the color version of this figure go to http://www.currentprotocols.com. Modeling Structure from Sequence Contributed by Narayanan Eswar, Ben Webb, Marc A. Marti-Renom, M.S. Madhusudhan, David 5.6.1 Eramian, Min-yi Shen, Ursula Pieper, and Andrej Sali (2006) 5.6.1-5.6.30 Current Protocols in Bioinformatics Supplement 15 Copyright C 2006 by John Wiley & Sons, Inc. ⃝ Table 5.6.1 Programs and Web Servers Useful in Comparative Protein Structure Modeling Name World Wide Web address Databases BALIBASE (Thompson et al., 1999) http://bips.u-strasbg.fr/en/Products/Databases/BAliBASE/
    [Show full text]
  • The 2000 Olympic Games of Protein Structure Prediction
    Protein Engineering vol.13 no.10 pp.667–669, 2000 COMMUNICATION The 2000 Olympic Games of protein structure prediction; fully automated programs are being evaluated vis-a`-vis human teams in the protein structure prediction experiment CAFASP2 Daniel Fischer1,2, Arne Elofsson3 and Leszek Rychlewski4 Assessment of Structure Prediction) (Moult et al., 1999) blind 1Bioinformatics, Department of Computer Science, Ben Gurion University, prediction experiment, devised by John Moult of the University Beer-Sheva 84015, Israel, 3Stockholm Bioinformatics Center, of Maryland in 1994. In CASP, a few dozen proteins of known 106 91 Stockholm, Sweden and 4International Institute of Molecular and sequence but unknown structure are used as prediction targets. Cell Biology, Ks. Trojdena 4, 02-109 Warsaw, Poland Contestants are asked to file their predictions before the real 2To whom correspondence should be addressed. 3D structure of the protein is experimentally determined. The E-mail: dfi[email protected] predictions are filed using various methods known in the field In this commentary, we describe two new protein structure as homology modeling, fold recognition or threading and ab prediction experiments being run in parallel with the initio. Subsequently, when the 3D structure is released, an CASP experiment, which together may be regarded as assessment of the accuracy of the predictions is carried out. the 2000 Olympic Games of structure prediction. The first This protocol ensures that no participant knows the correct new experiment is CAFASP, the Critical Assessment of answer while running his/her programs and, thus, the submitted Fully Automated Structure Prediction. In CAFASP, the responses effectively reflect the state of the art of blind participants are fully automated programs or Internet prediction at the time of the contest.
    [Show full text]
  • Algorithms for Protein Comparative Modelling and Some Evolutionary Implications
    Algorithms for Protein Comparative Modelling and Some Evolutionary Implications B runo C o n t r e r a s -M oreira 2003 Biomolecular Modelling Laboratory Cancer Research UK, London Research Institute 44 Lincoln’s Inn Fields, London, WC2A 3PX and Department of Biochemistry and Molecular Biology University College London Gower Street, London, WC2E 6BT Submitted in part fulfilment of the requirements for the degree of Doctor of Philosophy in Biochemistry of the University of London. UMI Number: U602512 All rights reserved INFORMATION TO ALL USERS The quality of this reproduction is dependent upon the quality of the copy submitted. In the unlikely event that the author did not send a complete manuscript and there are missing pages, these will be noted. Also, if material had to be removed, a note will indicate the deletion. Dissertation Publishing UMI U602512 Published by ProQuest LLC 2014. Copyright in the Dissertation held by the Author. Microform Edition © ProQuest LLC. All rights reserved. This work is protected against unauthorized copying under Title 17, United States Code. ProQuest LLC 789 East Eisenhower Parkway P.O. Box 1346 Ann Arbor, Ml 48106-1346 A mi familia, incluida Pili 3 Abstract Protein comparative modelling (CM) is a predictive technique to build an atomic model for a polypeptide chain, based on the experimentally determined structures of related pro­ teins (templates). It is widely used in Structural Biology, with applications ranging from mutation analysis, protein and drug design to function prediction and analysis, particu­ larly when there are no experimental structures of the protein of interest. Therefore, CM is an important tool to process the amount of data generated by genomic projects.
    [Show full text]
  • Livebench-6: Large-Scale Automated Evaluation of Protein Structure Prediction Servers
    PROTEINS: Structure, Function, and Genetics 53:542–547 (2003) LiveBench-6: Large-Scale Automated Evaluation of Protein Structure Prediction Servers Leszek Rychlewski,1* Daniel Fischer,2 and Arne Elofsson3 1Bioinformatics Laboratory, BioInfoBank Institute, Poznan, Poland 2Bioinformatics, Department of Computer Science, Ben Gurion University, Beer-Sheva, Israel 3Stockholm Bioinformatics Center, Stockholm University, Stockholm, Sweden ABSTRACT The aim of the LiveBench experi- proteins extracted weekly from the PDB result in a set of ment is to provide a continuous evaluation of struc- over 100 non-trivial targets submitted in 6 months. The ture prediction servers in order to inform potential collected predictions are evaluated automatically and the users about the current state-of-the-art structure summaries of the performance of participating servers are prediction tools and in order to help the developers updated continuously and available at the homepage of the to analyze and improve the services. This round of program http://BioInfo.PL/LiveBench/. The final summary the experiment was conducted in parallel to the presented in this manuscript is based on 98 targets blind CAFASP-3 evaluation experiment. The data submitted between August and December of 2002. collected almost simultaneously enables the com- parison of servers on two different benchmark sets. MATERIALS AND METHODS The number of servers has doubled from the last The CASP experiment is known to change the evalua- evaluated LiveBench-4 experiment completed in tion procedure with every new biannual session in a search April 2002, just before the beginning of CAFASP-3. for a single “best” scoring protocol. The LiveBench experi- This can be partially attributed to the rapid develop- ment is no exception to this practice.
    [Show full text]
  • State-Of-The-Art Bioinformatics Protein Structure Prediction Tools (Review)
    INTERNATIONAL JOURNAL OF MOLECULAR MEDICINE 28: 295-310, 2011 State-of-the-art bioinformatics protein structure prediction tools (Review) ATHANASIA PAVLOPOULOU1 and IOANNIS MICHALOPOULOS2 1Department of Pharmacy, School of Health Sciences, University of Patras, Rion-Patras; 2Cryobiology of Stem Cells, Centre of Immunology and Transplantation, Biomedical Research Foundation, Academy of Athens, Athens, Greece Received April 18, 2011; Accepted May 9, 2011 DOI: 10.3892/ijmm.2011.705 Abstract. Knowledge of the native structure of a protein data, the experimental determination of a protein structure could provide an understanding of the molecular basis of its and/or function is labour intensive, time consuming and function. However, in the postgenomics era, there is a growing expensive. As a result, the ‘sequence-structure gap’, the gap gap between proteins with experimentally determined between the number of protein sequences and the number of structures and proteins without known structures. To deal proteins with experimentally determined structure and with the overwhelming data, a collection of automated function, is growing rapidly. Therefore, the use of computa- methods as bioinformatics tools which determine the structure tional tools for assigning structure to a novel protein represents of a protein from its amino acid sequence have emerged. The the most efficient alternative to experimental methods (1). To aim of this paper is to provide the experimental biologists overcome this problem, a plethora of automated methods to with a set of cutting-edge, carefully evaluated, user-friendly predict protein structure have evolved as computational tools computational tools for protein structure prediction that would over the past decade (2). be helpful for the interpretation of their results and the rational In the present review, we present a set of state-of-the-art design of new experiments.
    [Show full text]
  • Automated Prediction of CASP-5 Structures Using the ROBETTA Server
    Automated prediction of CASP-5 structures using the ROBETTA server Dylan Chivian1, David E. Kim1, Lars Malmstrom1, Philip Bradley1, Timothy Robertson1, Paul Murphy1, Charles E.M. Strauss2, Richard Bonneau3, Carol A. Rohl4, and David Baker1* 1- University of Washington, Seattle, WA, USA 2- Los Alamos National Laboratory, Los Alamos, NM, USA 3- Institute for Systems Biology, Seattle, WA, USA 4- University of California, Santa Cruz, CA, USA *- [email protected] University of Washington Dept. of Biochemistry and HHMI Box 357350 Seattle, WA 98195 Phone: (206) 543-1295 Fax: (206) 685-1792 Keywords: Fully automated protein structure prediction server, CASP, CAFASP, Rosetta, fragment assembly, de novo modeling, template-based modeling, domain parsing, sequence alignment. ABSTRACT Robetta is a fully automated protein structure prediction server that uses the Rosetta fragment-insertion method. It combines template-based and de novo structure prediction methods in an attempt to produce high quality models that cover every residue of a submitted sequence. The first step in the procedure is the automatic detection of the locations of domains and selection of the appropriate modeling protocol for each domain. For domains matched to a homolog with an experimentally characterized structure by PSI-BLAST or Pcons2, Robetta uses a new alignment method, called K*Sync, to align the query sequence onto the parent structure. It then models the variable regions by allowing them to explore conformational space with fragments in fashion similar to the de novo protocol, but in the context of the template. When no structural homolog is available, domains are modeled with the Rosetta de novo protocol, which allows the full length of the domain to explore conformational space via fragment-insertion, producing a large decoy ensemble from which the final models are selected.
    [Show full text]
  • CAFASP3 in the Spotlight of EVA
    PROTEINS: Structure, Function, and Genetics 53:548–560 (2003) CAFASP3 in the Spotlight of EVA Volker A. Eyrich,1* Dariusz Przybylski,1,2,4 Ingrid Y.Y. Koh,1,2 Osvaldo Grana,5 Florencio Pazos,6 Alfonso Valencia,5 and Burkhard Rost1,2,3* 1CUBIC, Department of Biochemistry and Molecular Biophysics, Columbia University, New York, New York 2Columbia University Center for Computational Biology and Bioinformatics (C2B2), New York, New York 3North East Structural Genomics Consortium (NESG), Department of Biochemistry and Molecular Biophysics, Columbia University, New York, New York 4Department of Physics, Columbia University, New York, New York 5Protein Design Group, Centro Nacional de Biotecnologia (CNB-CSIC), Cantoblanco, Madrid, Spain 6ALMA Bioinformatica, Contoblanco, Madrid, Spain ABSTRACT We have analysed fold recogni- targets to servers as well as data collection and evaluation tion, secondary structure and contact prediction are fully automated and are capable of scaling up to much servers from CAFASP3. This assessment was car- larger numbers of prediction targets than CASP: despite ried out in the framework of the fully automated, the immense increase in the number of targets at CASP5, web-based evaluation server EVA. Detailed results over 100 times more targets have been handled by EVA are available at http://cubic.bioc.columbia.edu/eva/ between CASP4 and CASP5 than at CASP5 alone. Details cafasp3/. We observed that the sequence-unique tar- on the mechanism of data acquisition and the presentation gets from CAFASP3/CASP5 were not fully represen- of results are available from the web and our previous tative for evaluating performance. For all three publications;1,3,2 forthcoming publications will describe categories, we showed how careless ranking might the evaluation procedure in more detail.
    [Show full text]
  • Protein Structure Prediction in 2002 Jack Schonbrun, William J Wedemeyer and David Baker*
    sb120317.qxd 24/05/02 16:00 Page 348 348 Protein structure prediction in 2002 Jack Schonbrun, William J Wedemeyer and David Baker* Central issues concerning protein structure prediction have Traditionally, protein structure prediction is divided into been highlighted by the recently published summary of the three areas, depending on the similarity of the target to fourth community-wide protein structure prediction experiment proteins of known structure. First, in comparative modeling, (CASP4). Although sequence/structure alignment remains one or more template proteins of known structure with the bottleneck in comparative modeling, there has been high sequence homology to the target sequence are substantial progress in fully automated remote homolog identified. The target and template sequences are aligned, detection and in de novo structure prediction. Significant and a three-dimensional structure of the target protein is further progress will probably require improvements in generated from the coordinates of the aligned residues of high-resolution modeling. the template protein, combined with models for loop regions and other unaligned segments. Ideally, this three- Addresses dimensional model would then be refined to bring it closer Howard Hughes Medical Institute and Department of Biochemistry, to the true structure of the target protein. A key outstanding Box 357350, University of Washington, Seattle, Washington 98165, USA question is whether such refinement actually improves the *e-mail: [email protected] predicted structure, that is, whether the refined structure Current Opinion in Structural Biology 2002, 12:348–354 is closer to the native structure than the unrefined template structure. Second, if no reliable template protein can be 0959-440X/02/$ — see front matter © 2002 Elsevier Science Ltd.
    [Show full text]