Biopython Tutorial and Cookbook

Total Page:16

File Type:pdf, Size:1020Kb

Biopython Tutorial and Cookbook Biopython Tutorial and Cookbook Jeff Chang, Brad Chapman, Iddo Friedberg, Thomas Hamelryck, Michiel de Hoon, Peter Cock, Tiago Antao, Eric Talevich Last Update – 31 August 2010 (Biopython 1.55) Contents 1 Introduction 7 1.1 What is Biopython? ......................................... 7 1.2 What can I find in the Biopython package ............................. 7 1.3 Installing Biopython ......................................... 8 1.4 Frequently Asked Questions (FAQ) ................................. 8 2 Quick Start – What can you do with Biopython? 12 2.1 General overview of what Biopython provides ........................... 12 2.2 Working with sequences ....................................... 12 2.3 A usage example ........................................... 13 2.4 Parsing sequence file formats .................................... 14 2.4.1 Simple FASTA parsing example ............................... 14 2.4.2 Simple GenBank parsing example ............................. 15 2.4.3 I love parsing – please don’t stop talking about it! .................... 15 2.5 Connecting with biological databases ................................ 15 2.6 What to do next ........................................... 16 3 Sequence objects 17 3.1 Sequences and Alphabets ...................................... 17 3.2 Sequences act like strings ...................................... 18 3.3 Slicing a sequence .......................................... 19 3.4 Turning Seq objects into strings ................................... 20 3.5 Concatenating or adding sequences ................................. 20 3.6 Changing case ............................................. 21 3.7 Nucleotide sequences and (reverse) complements ......................... 21 3.8 Transcription ............................................. 22 3.9 Translation .............................................. 23 3.10 Translation Tables .......................................... 25 3.11 Comparing Seq objects ........................................ 27 3.12 MutableSeq objects .......................................... 28 3.13 UnknownSeq objects ......................................... 29 3.14 Working with directly strings .................................... 30 4 Sequence Record objects 31 4.1 The SeqRecord object ........................................ 31 4.2 Creating a SeqRecord ........................................ 32 4.2.1 SeqRecord objects from scratch ............................... 32 4.2.2 SeqRecord objects from FASTA files ............................ 33 4.2.3 SeqRecord objects from GenBank files ........................... 34 4.3 SeqFeature objects .......................................... 35 1 4.3.1 SeqFeatures themselves ................................... 35 4.3.2 Locations ........................................... 37 4.4 References ............................................... 38 4.5 The format method .......................................... 39 4.6 Slicing a SeqRecord ......................................... 39 4.7 Adding SeqRecord objects ...................................... 42 5 Sequence Input/Output 44 5.1 Parsing or Reading Sequences .................................... 44 5.1.1 Reading Sequence Files ................................... 44 5.1.2 Iterating over the records in a sequence file ........................ 45 5.1.3 Getting a list of the records in a sequence file ....................... 46 5.1.4 Extracting data ........................................ 47 5.2 Parsing sequences from the net ................................... 49 5.2.1 Parsing GenBank records from the net ........................... 49 5.2.2 Parsing SwissProt sequences from the net ......................... 50 5.3 Sequence files as Dictionaries – In memory ............................. 50 5.3.1 Specifying the dictionary keys ................................ 51 5.3.2 Indexing a dictionary using the SEGUID checksum .................... 52 5.4 Sequence files as Dictionaries – Indexed files ............................ 53 5.4.1 Specifying the dictionary keys ................................ 53 5.4.2 Getting the raw data for a record .............................. 54 5.4.3 Discussion ........................................... 54 5.5 Writing Sequence Files ........................................ 54 5.5.1 Round trips .......................................... 56 5.5.2 Converting between sequence file formats ......................... 56 5.5.3 Converting a file of sequences to their reverse complements ............... 57 5.5.4 Getting your SeqRecord objects as formatted strings ................... 58 6 Multiple Sequence Alignment objects 59 6.1 Parsing or Reading Sequence Alignments ............................. 59 6.1.1 Single Alignments ...................................... 60 6.1.2 Multiple Alignments ..................................... 62 6.1.3 Ambiguous Alignments ................................... 64 6.2 Writing Alignments .......................................... 66 6.2.1 Converting between sequence alignment file formats ................... 67 6.2.2 Getting your alignment objects as formatted strings ................... 69 6.3 Manipulating Alignments ...................................... 69 6.4 Alignment Tools ........................................... 72 6.4.1 ClustalW ........................................... 72 6.4.2 MUSCLE ........................................... 74 6.4.3 MUSCLE using stdout .................................... 75 6.4.4 MUSCLE using stdin and stdout .............................. 76 6.4.5 EMBOSS needle and water ................................. 77 7 BLAST 80 7.1 Running BLAST over the Internet ................................. 80 7.2 Running BLAST locally ....................................... 82 7.2.1 Introduction ......................................... 82 7.2.2 Standalone NCBI “legacy” BLAST ............................. 82 7.2.3 Standalone NCBI BLAST+ ................................. 82 7.2.4 WU-BLAST and AB-BLAST ................................ 83 2 7.3 Parsing BLAST output ....................................... 83 7.4 The BLAST record class ....................................... 85 7.5 Deprecated BLAST parsers ..................................... 86 7.5.1 Parsing plain-text BLAST output ............................. 86 7.5.2 Parsing a plain-text BLAST file full of BLAST runs ................... 89 7.5.3 Finding a bad record somewhere in a huge plain-text BLAST file ............ 90 7.6 Dealing with PSI-BLAST ...................................... 91 7.7 Dealing with RPS-BLAST ...................................... 91 8 Accessing NCBI’s Entrez databases 92 8.1 Entrez Guidelines ........................................... 93 8.2 EInfo: Obtaining information about the Entrez databases .................... 93 8.3 ESearch: Searching the Entrez databases .............................. 95 8.4 EPost: Uploading a list of identifiers ................................ 96 8.5 ESummary: Retrieving summaries from primary IDs ....................... 97 8.6 EFetch: Downloading full records from Entrez ........................... 97 8.7 ELink: Searching for related items in NCBI Entrez ........................ 100 8.8 EGQuery: Global Query - counts for search terms ........................ 101 8.9 ESpell: Obtaining spelling suggestions ............................... 102 8.10 Parsing huge Entrez XML files ................................... 102 8.11 Specialized parsers .......................................... 103 8.11.1 Parsing Medline records ................................... 103 8.11.2 Parsing GEO records ..................................... 105 8.11.3 Parsing UniGene records ................................... 106 8.12 Using a proxy ............................................. 107 8.13 Examples ............................................... 108 8.13.1 PubMed and Medline .................................... 108 8.13.2 Searching, downloading, and parsing Entrez Nucleotide records ............. 109 8.13.3 Searching, downloading, and parsing GenBank records .................. 111 8.13.4 Finding the lineage of an organism ............................. 112 8.14 Using the history and WebEnv ................................... 113 8.14.1 Searching for and downloading sequences using the history ............... 113 8.14.2 Searching for and downloading abstracts using the history ................ 114 8.14.3 Searching for citations .................................... 114 9 Swiss-Prot and ExPASy 116 9.1 Parsing Swiss-Prot files ....................................... 116 9.1.1 Parsing Swiss-Prot records ................................. 116 9.1.2 Parsing the Swiss-Prot keyword and category list ..................... 118 9.2 Parsing Prosite records ........................................ 119 9.3 Parsing Prosite documentation records ............................... 120 9.4 Parsing Enzyme records ....................................... 120 9.5 Accessing the ExPASy server .................................... 122 9.5.1 Retrieving a Swiss-Prot record ............................... 122 9.5.2 Searching Swiss-Prot ..................................... 123 9.5.3 Retrieving Prosite and Prosite documentation records .................. 123 9.6 Scanning the Prosite database .................................... 124 3 10 Going 3D: The PDB module 126 10.1 Structure representation ....................................... 126 10.1.1 Structure ........................................... 128 10.1.2 Model ............................................. 129 10.1.3 Chain ............................................
Recommended publications
  • Python Data Analytics Open a File for Reading: Infile = Open("Input.Txt", "R")
    DATA 301: Data Analytics (2) Python File Input/Output DATA 301 Many data processing tasks require reading and writing to files. Introduction to Data Analytics I/O Type Python Data Analytics Open a file for reading: infile = open("input.txt", "r") Dr. Ramon Lawrence Open a file for writing: University of British Columbia Okanagan outfile = open("output.txt", "w") [email protected] Open a file for read/write: myfile = open("data.txt", "r+") DATA 301: Data Analytics (3) DATA 301: Data Analytics (4) Reading from a Text File (as one String) Reading from a Text File (line by line) infile = open("input.txt", "r") infile = open("input.txt", "r") for line in infile: print(line.strip('\n')) val = infile.read() Read all file as one string infile.close() print(val) infile.close() Close file # Alternate syntax - will auto-close file with open("input.txt", "r") as infile: for line in infile: print(line.strip('\n')) DATA 301: Data Analytics (5) DATA 301: Data Analytics (6) Writing to a Text File Other File Methods outfile = open("output.txt", "w") infile = open("input.txt", "r") for n in range(1,11): # Check if a file is closed outfile.write(str(n) + "\n") print(infile.closed)# False outfile.close() # Read all lines in the file into a list lines = infile.readlines() infile.close() print(infile.closed)# True DATA 301: Data Analytics (7) DATA 301: Data Analytics (8) Use Split to Process a CSV File Using csv Module to Process a CSV File with open("data.csv", "r") as infile: import csv for line in infile: line = line.strip(" \n") with open("data.csv", "r") as infile: fields = line.split(",") csvfile = csv.reader(infile) for i in range(0,len(fields)): for row in csvfile: fields[i] = fields[i].strip() if int(row[0]) > 1: print(fields) print(row) DATA 301: Data Analytics (9) DATA 301: Data Analytics (10) List all Files in a Directory Python File I/O Question Question: How many of the following statements are TRUE? import os print(os.listdir(".")) 1) A Python file is automatically closed for you.
    [Show full text]
  • Biopython BOSC 2007
    The 8th annual Bioinformatics Open Source Conference (BOSC 2007) 18th July, Vienna, Austria Biopython Project Update Peter Cock, MOAC Doctoral Training Centre, University of Warwick, UK Talk Outline What is python? What is Biopython? Short history Project organisation What can you do with it? How can you contribute? Acknowledgements The 8th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria What is Python? High level programming language Object orientated Open Source, free ($$$) Cross platform: Linux, Windows, Mac OS X, … Extensible in C, C++, … The 8th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria What is Biopython? Set of libraries for computational biology Open Source, free ($$$) Cross platform: Linux, Windows, Mac OS X, … Sibling project to BioPerl, BioRuby, BioJava, … The 8th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria Popularity by Google Hits Python 98 million Biopython 252,000 Perl 101 million BioPerlBioPerl 610,000 Ruby 101 million BioRuby 122,000 Java 289 million BioJava 185,000 Both Perl and Python are strong at text Python may have the edge for numerical work (with the Numerical python libraries) The 8th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria Biopython history 1999 : Started by Jeff Chang & Andrew Dalke 2000 : Biopython 0.90, first release 2001 : Biopython 1.00, “semi-complete” 2002
    [Show full text]
  • The Bioperl Toolkit: Perl Modules for the Life Sciences
    Downloaded from genome.cshlp.org on January 25, 2012 - Published by Cold Spring Harbor Laboratory Press The Bioperl Toolkit: Perl Modules for the Life Sciences Jason E. Stajich, David Block, Kris Boulez, et al. Genome Res. 2002 12: 1611-1618 Access the most recent version at doi:10.1101/gr.361602 Supplemental http://genome.cshlp.org/content/suppl/2002/10/20/12.10.1611.DC1.html Material References This article cites 14 articles, 9 of which can be accessed free at: http://genome.cshlp.org/content/12/10/1611.full.html#ref-list-1 Article cited in: http://genome.cshlp.org/content/12/10/1611.full.html#related-urls Email alerting Receive free email alerts when new articles cite this article - sign up in the box at the service top right corner of the article or click here To subscribe to Genome Research go to: http://genome.cshlp.org/subscriptions Cold Spring Harbor Laboratory Press Downloaded from genome.cshlp.org on January 25, 2012 - Published by Cold Spring Harbor Laboratory Press Resource The Bioperl Toolkit: Perl Modules for the Life Sciences Jason E. Stajich,1,18,19 David Block,2,18 Kris Boulez,3 Steven E. Brenner,4 Stephen A. Chervitz,5 Chris Dagdigian,6 Georg Fuellen,7 James G.R. Gilbert,8 Ian Korf,9 Hilmar Lapp,10 Heikki Lehva¨slaiho,11 Chad Matsalla,12 Chris J. Mungall,13 Brian I. Osborne,14 Matthew R. Pocock,8 Peter Schattner,15 Martin Senger,11 Lincoln D. Stein,16 Elia Stupka,17 Mark D. Wilkinson,2 and Ewan Birney11 1University Program in Genetics, Duke University, Durham, North Carolina 27710, USA; 2National Research Council of
    [Show full text]
  • HMMER User's Guide
    HMMER User’s Guide Biological sequence analysis using profile hidden Markov models http://hmmer.org/ Version 3.0rc1; February 2010 Sean R. Eddy for the HMMER Development Team Janelia Farm Research Campus 19700 Helix Drive Ashburn VA 20147 USA http://eddylab.org/ Copyright (C) 2010 Howard Hughes Medical Institute. Permission is granted to make and distribute verbatim copies of this manual provided the copyright notice and this permission notice are retained on all copies. HMMER is licensed and freely distributed under the GNU General Public License version 3 (GPLv3). For a copy of the License, see http://www.gnu.org/licenses/. HMMER is a trademark of the Howard Hughes Medical Institute. 1 Contents 1 Introduction 5 How to avoid reading this manual . 5 How to avoid using this software (links to similar software) . 5 What profile HMMs are . 5 Applications of profile HMMs . 6 Design goals of HMMER3 . 7 What’s still missing in HMMER3 . 8 How to learn more about profile HMMs . 9 2 Installation 10 Quick installation instructions . 10 System requirements . 10 Multithreaded parallelization for multicores is the default . 11 MPI parallelization for clusters is optional . 11 Using build directories . 12 Makefile targets . 12 3 Tutorial 13 The programs in HMMER . 13 Files used in the tutorial . 13 Searching a sequence database with a single profile HMM . 14 Step 1: build a profile HMM with hmmbuild . 14 Step 2: search the sequence database with hmmsearch . 16 Searching a profile HMM database with a query sequence . 22 Step 1: create an HMM database flatfile . 22 Step 2: compress and index the flatfile with hmmpress .
    [Show full text]
  • Bioinformatics and Computational Biology with Biopython
    Biopython 1 Bioinformatics and Computational Biology with Biopython Michiel J.L. de Hoon1 Brad Chapman2 Iddo Friedberg3 [email protected] [email protected] [email protected] 1 Human Genome Center, Institute of Medical Science, University of Tokyo, 4-6-1 Shirokane-dai, Minato-ku, Tokyo 108-8639, Japan 2 Plant Genome Mapping Laboratory, University of Georgia, Athens, GA 30602, USA 3 The Burnham Institute, 10901 North Torrey Pines Road, La Jolla, CA 92037, USA Keywords: Python, scripting language, open source 1 Introduction In recent years, high-level scripting languages such as Python, Perl, and Ruby have gained widespread use in bioinformatics. Python [3] is particularly useful for bioinformatics as well as computational biology because of its numerical capabilities through the Numerical Python project [1], in addition to the features typically found in scripting languages. Because of its clear syntax, Python is remarkably easy to learn, making it suitable for occasional as well as experienced programmers. The open-source Biopython project [2] is an international collaboration that develops libraries for Python to facilitate common tasks in bioinformatics. 2 Summary of current features of Biopython Biopython contains parsers for a large number of file formats such as BLAST, FASTA, Swiss-Prot, PubMed, KEGG, GenBank, AlignACE, Prosite, LocusLink, and PDB. Sequences are described by a standard object-oriented representation, creating an integrated framework for manipulating and ana- lyzing such sequences. Biopython enables users to
    [Show full text]
  • Biopython Project Update 2013
    Biopython Project Update 2013 Peter Cock & the Biopython Developers, BOSC 2013, Berlin, Germany Twitter: @pjacock & @biopython Introduction 2 My Employer After PhD joined Scottish Crop Research Institute In 2011, SCRI (Dundee) & MLURI (Aberdeen) merged as The James Hutton Institute Government funded research institute I work mainly on the genomics of Plant Pathogens I use Biopython in my day to day work More about this in tomorrow’s panel discussion, “Strategies for Funding and Maintaining Open Source Software” 3 Biopython Open source bioinformatics library for Python Sister project to: BioPerl BioRuby BioJava EMBOSS etc (see OBF Project BOF meeting tonight) Long running! 4 Brief History of Biopython 1999 - Started by Andrew Dalke & Jef Chang 2000 - First release, announcement publication Chapman & Chang (2000). ACM SIGBIO Newsletter 20, 15-19 2001 - Biopython 1.00 2009 - Application note publication Cock et al. (2009) DOI:10.1093/bioinformatics/btp163 2011 - Biopython 1.57 and 1.58 2012 - Biopython 1.59 and 1.60 2013 - Biopython 1.61 and 1.62 beta 5 Recap from last BOSC 2012 Eric Talevich presented in Boston Biopython 1.58, 1.59 and 1.60 Visualization enhancements for chromosome and genome diagrams, and phylogenetic trees More file format parsers BGZF compression Google Summer of Code students ... Bio.Phylo paper submitted and in review ... Biopython working nicely under PyPy 1.9 ... 6 Publications 7 Bio.Phylo paper published Talevich et al (2012) DOI:10.1186/1471-2105-13-209 Talevich et al. BMC Bioinformatics 2012, 13:209 http://www.biomedcentral.com/1471-2105/13/209 SOFTWARE OpenAccess Bio.Phylo: A unified toolkit for processing, analyzing and visualizing phylogenetic trees in Biopython Eric Talevich1*, Brandon M Invergo2,PeterJACock3 and Brad A Chapman4 Abstract Background: Ongoing innovation in phylogenetics and evolutionary biology has been accompanied by a proliferation of software tools, data formats, analytical techniques and web servers.
    [Show full text]
  • Biopython Tutorial and Cookbook
    Biopython Tutorial and Cookbook Jeff Chang, Brad Chapman, Iddo Friedberg, Thomas Hamelryck Last Update{15 June 2003 Contents 1 Introduction 4 1.1 What is Biopython?.........................................4 1.1.1 What can I find in the biopython package.........................4 1.2 Installing Biopython.........................................5 1.3 FAQ..................................................5 2 Quick Start { What can you do with Biopython?6 2.1 General overview of what Biopython provides...........................6 2.2 Working with sequences.......................................6 2.3 A usage example........................................... 10 2.4 Parsing biological file formats.................................... 10 2.4.1 General parser design.................................... 10 2.4.2 Writing your own consumer................................. 11 2.4.3 Making it easier....................................... 13 2.4.4 FASTA files as Dictionaries................................. 14 2.4.5 I love parsing { please don't stop talking about it!.................... 16 2.5 Connecting with biological databases................................ 16 2.6 What to do next........................................... 17 3 Cookbook { Cool things to do with it 18 3.1 BLAST................................................ 18 3.1.1 Running BLAST over the internet............................. 18 3.1.2 Parsing the output from the WWW version of BLAST.................. 19 3.1.3 The BLAST record class................................... 21 3.1.4 Running BLAST
    [Show full text]
  • Validation and Annotation of Virus Sequence Submissions to Genbank Alejandro A
    Schäffer et al. BMC Bioinformatics (2020) 21:211 https://doi.org/10.1186/s12859-020-3537-3 SOFTWARE Open Access VADR: validation and annotation of virus sequence submissions to GenBank Alejandro A. Schäffer1,2, Eneida L. Hatcher2, Linda Yankie2, Lara Shonkwiler2,3,J.RodneyBrister2, Ilene Karsch-Mizrachi2 and Eric P. Nawrocki2* *Correspondence: [email protected] Abstract 2National Center for Biotechnology Background: GenBank contains over 3 million viral sequences. The National Center Information, National Library of for Biotechnology Information (NCBI) previously made available a tool for validating Medicine, National Institutes of Health, Bethesda, MD, 20894 USA and annotating influenza virus sequences that is used to check submissions to Full list of author information is GenBank. Before this project, there was no analogous tool in use for non-influenza viral available at the end of the article sequence submissions. Results: We developed a system called VADR (Viral Annotation DefineR) that validates and annotates viral sequences in GenBank submissions. The annotation system is based on the analysis of the input nucleotide sequence using models built from curated RefSeqs. Hidden Markov models are used to classify sequences by determining the RefSeq they are most similar to, and feature annotation from the RefSeq is mapped based on a nucleotide alignment of the full sequence to a covariance model. Predicted proteins encoded by the sequence are validated with nucleotide-to-protein alignments using BLAST. The system identifies 43 types of “alerts” that (unlike the previous BLAST-based system) provide deterministic and rigorous feedback to researchers who submit sequences with unexpected characteristics. VADR has been integrated into GenBank’s submission processing pipeline allowing for viral submissions passing all tests to be accepted and annotated automatically, without the need for any human (GenBank indexer) intervention.
    [Show full text]
  • RNA Ontology Consortium January 8-9, 2011
    UC San Diego UC San Diego Previously Published Works Title Meeting report of the RNA Ontology Consortium January 8-9, 2011. Permalink https://escholarship.org/uc/item/0kw6h252 Journal Standards in genomic sciences, 4(2) ISSN 1944-3277 Authors Birmingham, Amanda Clemente, Jose C Desai, Narayan et al. Publication Date 2011-04-01 DOI 10.4056/sigs.1724282 Peer reviewed eScholarship.org Powered by the California Digital Library University of California Standards in Genomic Sciences (2011) 4:252-256 DOI:10.4056/sigs.1724282 Meeting report of the RNA Ontology Consortium January 8-9, 2011 Amanda Birmingham1, Jose C. Clemente2, Narayan Desai3, Jack Gilbert3,4, Antonio Gonzalez2, Nikos Kyrpides5, Folker Meyer3,6, Eric Nawrocki7, Peter Sterk8, Jesse Stombaugh2, Zasha Weinberg9,10, Doug Wendel2, Neocles B. Leontis11, Craig Zirbel12, Rob Knight2,13, Alain Laederach14 1 Thermo Fisher Scientific, Lafayette, CO, USA 2 Department of Chemistry and Biochemistry, University of Colorado, Boulder, CO, USA 3 Argonne National Laboratory, Argonne, IL, USA 4 Department of Ecology and Evolution, University of Chicago, Chicago, IL, USA 5 DOE Joint Genome Institute, Walnut Creek, CA, USA 6 Computation Institute, University of Chicago, Chicago, IL, USA 7 Janelia Farm Research Campus, Howard Hughes Medical Institute, Ashburn, VA, USA 8 Wellcome Trust Sanger Institute, Wellcome Trust Genome Campus, Hinxton, Cambridge, UK 9 Department of Molecular, Cellular and Developmental, Yale University, New Haven, CT, USA 10 Howard Hughes Medical Institute, Yale University, New
    [Show full text]
  • Why Do We Want to Use Python for Bioinformatics? Biopython
    Why do we want to use Python for bioinformatics? Some examples: 3d Modeling of proteins and protein dynamics: https://pymol.org/2/ PyMOL 2.3 PyMOL is a user-sponsored molecular visualization system on an open-source foundation. Machine Learning tools: scikit-learn keras Tensorflow Pytorch Biopython https://biopython.org Biopython 1.73 The Biopython Project is an international association of developers of freely available Python (http://w w w . python.org) tools for computational biology. Similarly, there exist BioPerl and BioJava Projects. >>> import Bio from Bio.Seq import Seq #create a sequence object my_seq = Seq('CATGTAGACTAG') #print out some details about it print 'seq %s is %i bases long' % (my_seq, len(my_seq)) print 'reverse complement is %s' % my_seq.reverse_complement() print 'protein translation is %s' % my_seq.translate() ###OUTPUT seq CATGTAGACTAG is 12 bases long reverse complement is CTAGTCTACATG protein translation is HVD* Use the SeqIO module for reading or w riting sequences as SeqRecord objects. For multiple sequence alignment files, you can alternatively use the AlignIO module. Tutorial online: http://biopython.org/DIST/docs/tutorial/Tutorial.html The main Biopython releases have lots of functionality, including: • The ability to parse bioinformatics files into Python utilizable data structures, including support for the following formats: – Blast output – both from standalone and WWW Blast – Clustalw – FASTA – GenBank (NCBI annoted collection of public DNA sequences) – PubMed and Medline – ExPASy files, like Enzyme and Prosite (Protein DB) ExPasy is a bioinformatics portal operated by the Swiss Institute of Bioinformatics – UniGene – SwissProt (Proteic sequences DB) • Files in the supported formats can be iterated over record by record or indexed and accessed via a Dictionary interface.
    [Show full text]
  • Tools for Simulating Evolution of Aligned Genomic Regions with Integrated Parameter Estimation Avinash Varadarajan*, Robert K Bradley† and Ian H Holmes†‡
    Open Access Software2008VaradarajanetVolume al. 9, Issue 10, Article R147 Tools for simulating evolution of aligned genomic regions with integrated parameter estimation Avinash Varadarajan*, Robert K Bradley and Ian H Holmes Addresses: *Computer Science Division, University of California, Berkeley, CA 94720-1776, USA. Biophysics Graduate Group, University of California, Berkeley, CA 94720-3200, USA. Department of Bioengineering, University of California, Berkeley, CA 94720-1762, USA. Correspondence: Ian H Holmes. Email: [email protected] Published: 8 October 2008 Received: 20 June 2008 Revised: 21 August 2008 Genome Biology 2008, 9:R147 (doi:10.1186/gb-2008-9-10-r147) Accepted: 8 October 2008 The electronic version of this article is the complete one and can be found online at http://genomebiology.com/2008/9/10/R147 © 2008 Varadarajan et al.; licensee BioMed Central Ltd. This is an open access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/2.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited. Simulation<p>Threefor richly structured tools of genome for simulating syntenic evolution blocks genome of genomeevolution sequence.</p> are presented: for neutrally evolving DNA, for phylogenetic context-free grammars and Abstract Controlled simulations of genome evolution are useful for benchmarking tools. However, many simulators lack extensibility and cannot measure parameters directly from data. These issues are addressed by three new open-source programs: GSIMULATOR (for neutrally evolving DNA), SIMGRAM (for generic structured features) and SIMGENOME (for syntenic genome blocks). Each offers algorithms for parameter measurement and reconstruction of ancestral sequence.
    [Show full text]
  • INFERNAL User's Guide
    INFERNAL User’s Guide Sequence analysis using profiles of RNA sequence and secondary structure consensus http://eddylab.org/infernal Version 1.1.4; Dec 2020 Eric Nawrocki and Sean Eddy for the INFERNAL development team https://github.com/EddyRivasLab/infernal/ Copyright (C) 2020 Howard Hughes Medical Institute. Infernal and its documentation are freely distributed under the 3-Clause BSD open source license. For a copy of the license, see http://opensource.org/licenses/BSD-3-Clause. Infernal development is supported by the Intramural Research Program of the National Library of Medicine at the US National Institutes of Health, and also by the National Human Genome Research Institute of the US National Institutes of Health under grant number R01HG009116. The content is solely the responsibility of the authors and does not necessarily represent the official views of the National Institutes of Health. 1 Contents 1 Introduction 6 How to avoid reading this manual . 6 What covariance models are . 6 Applications of covariance models . 7 Infernal and HMMER, CMs and profile HMMs . 7 What’s new in Infernal 1.1 . 8 How to learn more about CMs and profile HMMs . 8 2 Installation 10 Quick installation instructions . 10 System requirements . 10 Multithreaded parallelization for multicores is the default . 11 MPI parallelization for clusters is optional . 11 Using build directories . 12 Makefile targets . 12 Why is the output of ’make’ so clean? . 12 What gets installed by ’make install’, and where? . 12 Staged installations in a buildroot, for a packaging system . 13 Workarounds for some unusual configure/compilation problems . 13 3 Tutorial 15 The programs in Infernal .
    [Show full text]