Efficient Selection of Unique and Popular Oligos for Large EST Databases. Stefano Lonardi. University of California, Riverside

Size: px
Start display at page:

Download "Efficient Selection of Unique and Popular Oligos for Large EST Databases. Stefano Lonardi. University of California, Riverside"

Transcription

1 Efficient Selection of Unique and Popular Oligos for Large EST Databases Stefano Lonardi University of California, Riverside joint work with Jie Zheng, Timothy Close, Tao Jiang University of California, Riverside General problem Input: A list of DNA sequences Output: A list of short DNA strings of length -5 bases (oligos) occur only once in each DNA sequence ( unique oligos problem) or occur in as many DNA sequences as possible ( popular oligos problem)

2 Barley genome (H. vulgare) Size is 5x 9 bases times the size of Rice 5 times the size of Arabidopsis Too large for whole sequencing Strategy Build a BAC library of Barley Identify/sequence only the BACs containing the genes (expected %) Method An EST database for Barley is available Use the EST db to identify a set of popular oligos that hybridize with as many genes/est as possible (maximize coverage) Use as little oligos/filter/screens as possible (minimize time and money)

3 Objectives Maximize the coverage ratio (number of covered ESTs/number of oligos) Minimize the computational resources (memory, time) Barley EST db Composed by 5K EST sequences Cleaned (quality-trimming, cleaned of contaminants, etc.) Assembled (pre-clustered, assembled) Final dataset (HarvEST v.7) 46,45 unigenes 8,475,6 bases

4 Related work Pattern discovery (Meme, Teiresias, Pratt, Gibbs, Projection, Weeder, etc.) cannot be used because of the large input size Primer/probe design typically use all-againstall BLAST (eg., [Li&Stormo ], [Rouillard et al. ]) are extremely slow Rahmann [CSB ] uses suffix arrays (requires 5 hours on Compaq Alpha with 6GB RAM on a dataset of 4Mbases) Def: (c,d)-match Given integers c and d and strings w and y, w = y, we say that w (c,d)-match y iff w and y can be partitioned in substrings w=w w w and y=y y y such that w = y and w = y w w w w =y, w = y =c (core) H(w w,y y )=d acaatatgagaccctt agaatatgagacgcat y y l=6, c=8, d= y

5 Def: (c,d)-coverage Given a set X={x,,x k }, a string y and integers c and d, the (c,d)-coverage of y is the number of sequences of X containing each at least one (c,d)-match of y Integer l to denote the length of y (l-mer) popular oligos problem Given X={x,,x k } and integers l, d, c and T, find all strings of length l such that their (c,d)-coverage in X is =T We call these strings popular oligos In our experiments l=6, c=, d= or, T= 5

6 Observations Note that a popular oligo may never appear exactly in X Enumerating/counting all l c ( ) d d Σ possible (c,d)-matches of each l-mer in X is computationally impractical For example, if l=6, c=, d=, S =4, one should count 5K (,)-matches for each 6mer. We have *8M 6mers, for a total of 846B elementary operations Heuristics: phase one Build an hash table for the cores For each core w that appears in =T c (core coverage threshold) sequences Collect all flanking regions w w, such that w w w is an l-mer with popular core w Run phase two on set of all extensions w w

7 Example: phase one >EST TGGAGTCCTCGGACACGATCACATCGACAATGTGAA GGCGA >EST GTGAAGGAGGTAGATCAAATAGAGCCTGCCCTAAAA AGGCAGCTTATAATCTCCACTGCT >EST TCCGACTACTGCACCCCGAGCGGATCACACAATGGAA GGCCCGTGCGC >EST GTGAAGGAGGTAGATACTCGTATACGATCACTGCCTA AAAAGGCAGCTTATAATCTCCATATCGCTG GAAGG TGAAG ATCAC AAGGC GTGAA GATCA ACTGC l=8, c=5, d=, T c = Example: phase one >EST TGGAGTCCTCGGACACGATCACATCGACAATGTGAA GGCGA >EST GTGAAGGAGGTAGATCAAATAGAGCCTGCCCTAAAA AGGCAGCTTATAATCTCCACTGCT >EST TCCGACTACTGCACCCCGAGCGGATCACACAATGGAA GGCCCGTGCGC >EST GTGAAGGAGGTAGATACTCGTATACGATCACTGCCTA AAAAGGCAGCTTATAATCTCCATATCGCTG GAAGG TGAAG ATCAC AAGGC GTGAA GATCA ACTGC l=8, c=5, d=, T c =

8 Heuristics: phase two (UPGMA) Place all w w at the leaves of the tree & merge identical leaves Build the UPGMA* tree on Hamming distance Create a set of d-mutants for each string in the leaves of the tree Traverse the tree bottom-up performing set intersection as soon as intersection is empty, separate the subtree from the rest of the tree The sets at the root of each tree in the forest represent the candidate popular oligo * Unweighed Pair Group Method with Arithmetic Mean Example : phase two (UPGMA) core AAGGC occurrences GTG AAGGC GA. GTG. TGG AAA AAGGC AGC. AAA. AAA TGG AAGGC CCG. TGG. GGC AAA AAGGC AGC 4. AAA 4. AAA set set core flanking region. GGA. AAG. AGC. GCC. CCG 4. AAG. AGC set set 4 l=8, c=5, d=, T c =

9 Example : phase two (UPGMA) core AAGGC occurrences GTG AAGGC GA. GTG. TGG AAA AAGGC AGC. AAA. AAA TGG AAGGC CCG. TGG. GGC AAA AAGGC AGC 4. AAA 4. AAA set set core flanking region. GGA. AAG. AGC. GCC. CCG 4. AAG. AGC set set 4 l=8, c=5, d=, T c = Example : phase two (UPGMA) set 4 TGG AAA GGC AAA 4 Before compression make tree I I AAA AAA 4 TGG GCG I (, 4) TGG I make tree (, 4) AAA I GGC TGG GCG (, AAA 4) After compression I l=8, c=5, d=, T c =

10 Example : phase two (UPGMA) set 4 TGG AAA GGC AAA 4 Before compression make tree AAA AAA 4 TGG GCG H(AAA,AAA)= (, 4) I TGG I make tree (, 4) AAA I GGC TGG GCG (, AAA 4) After compression I I I l=8, c=5, d=, T c = Example : phase two (UPGMA) -mutants of AAA: -mutants of TGG: -mutants of GGC: CAA AGG AGC GAA TAA ACA AGA ATA AAC AAG AAT CGG GGG TAG TCG TTG TGA TGC TGT CGC TGC GAC GCC GTC GGA GGG GGT AAA TGG GCG I I (, 4) TGG GCG AAA = emtpy I I cut tree TGG GCG cluster I (, AAA 4) cluster Candidates (from core AAGGC): AAAAGGCA AGAAGGCA GGAAGGCG CAAAGGCA ATAAGGCA ACAAGGCA TGAAGGCC GAAAGGCA AAAAGGCC TAAAGGCA AAAAGGCG AAAAGGCT l=8, c=5, d=, T c =

11 Example : phase two (UPGMA) -mutants of AAA: -mutants of TGG: -mutants of GGC: CAA AGG AGC GAA TAA ACA AGA ATA AAC AAG AAT CGG GGG TAG TCG TTG TGA TGC TGT CGC TGC GAC GCC GTC GGA GGG GGT AAA TGG GCG I I (, 4) TGG GCG AAA = emtpy I I cut tree TGG GCG cluster I (, AAA 4) cluster Candidates (from core AAGGC): AAAAGGCA AGAAGGCA GGAAGGCG CAAAGGCA ATAAGGCA ACAAGGCA TGAAGGCC GAAAGGCA AAAAGGCC TAAAGGCA AAAAGGCG AAAAGGCT l=8, c=5, d=, T c = Heuristics: phase three Radix sort the candidate oligos to remove duplicates Discard unsuitable oligos low-complexity strings (polya, polyt, etc.) 44% < GC-content < 56% Compute coverage Compress/correct oligos

12 Overview: phase one Output oligos Input EST Hashing Compute Coverage Table of seeds Table of popular cores Compression & correction Select Compute Coverage Collect flanking regions 7 sets of 6-mers that share the core at a specific position... Discard unsuitable oligos set set set 7 Build tree Compute candidates Cut tree List of candidates UPGMA tree Overview: phase two (UPGMA) Output oligos Input EST Hashing Compute Coverage Table of seeds Table of popular cores Compression & correction Select Compute Coverage Collect flanking regions 7 sets of 6-mers that share the core at a specific position... Discard unsuitable oligos set set set 7 Build tree Compute candidates Cut tree List of candidates UPGMA tree

13 Overview: phase three Output oligos Input EST Hashing Compute Coverage Table of seeds Table of popular cores Compression & correction Select Compute Coverage Collect flanking regions 7 sets of 6-mers that share the core at a specific position... Discard unsuitable oligos set set set 7 Build tree Compute candidates Cut tree List of candidates UPGMA tree Limitation of the heuristics Cores which have coverage below T c are called unpopular A l-mer can (c,d)-match with any of its l- c+ cores We will miss popular oligos which popularity depend on a combination of several unpopular cores

14 Simulations Generate {x,,x k } random sequences Inject {I,,I s } popular oligos with d errors outside a core of length c, with coverage {C,,C s } (Gaussian distribution, max coverage R) Run the popular oligo algorithm on {x,,x k } Simulation Obtain {O,,O t } with coverage {C,,C s } (sorted) {O,,O t } is compressed Compare (I,C) with (O,C ) For each =i=u for u=min(s,t) we compute u Ci C ECC (, ') = u C ' i= i i '

15 Simulation results k=, x i =7, c=, s=, R= E* T c = T c =5 T c = T c =5 T c = d= We never miss any oligo whose coverage is above T c + d= Experimental results l=6 (oligo length) c= (core length) d=, (max mismatches outside core) T c =varies (core coverage threshold) k=46,45 unigenes n=8 million bases PC with. GHz CPU and GB memory

16 Coverage graph 78 8½h ½h 8 ½h core coverage threshold unigene covered oligos candidates (M) time (min) coverage ratio Current & Future work Progressive processing to reduce memory requirements Fine tuning & optimization of the code New strategies to improve coverage ratio New definition for popular/unique oligos Parallel implementation

17 Complexity Build a seed table O(cn) Collect flanking substrings O(nr(l-c)) where r is # occurrences of cores Building UPGMA l c O r d Counting colors for m candidate O(rm(l-c)) d

18 UPGMA + intersection TGG GGG TGC GCG AAA

Genome Reconstruction: A Puzzle with a Billion Pieces Phillip E. C. Compeau and Pavel A. Pevzner

Genome Reconstruction: A Puzzle with a Billion Pieces Phillip E. C. Compeau and Pavel A. Pevzner Genome Reconstruction: A Puzzle with a Billion Pieces Phillip E. C. Compeau and Pavel A. Pevzner Outline I. Problem II. Two Historical Detours III.Example IV.The Mathematics of DNA Sequencing V.Complications

More information

by the Genevestigator program (www.genevestigator.com). Darker blue color indicates higher gene expression.

by the Genevestigator program (www.genevestigator.com). Darker blue color indicates higher gene expression. Figure S1. Tissue-specific expression profile of the genes that were screened through the RHEPatmatch and root-specific microarray filters. The gene expression profile (heat map) was drawn by the Genevestigator

More information

Pyramidal and Chiral Groupings of Gold Nanocrystals Assembled Using DNA Scaffolds

Pyramidal and Chiral Groupings of Gold Nanocrystals Assembled Using DNA Scaffolds Pyramidal and Chiral Groupings of Gold Nanocrystals Assembled Using DNA Scaffolds February 27, 2009 Alexander Mastroianni, Shelley Claridge, A. Paul Alivisatos Department of Chemistry, University of California,

More information

BIOINFORMATICS. Efficient selection of unique and popular oligos for large EST databases

BIOINFORMATICS. Efficient selection of unique and popular oligos for large EST databases BIOINFORMATICS Vol. 0 no. 004, pages 0 doi:0.09/bioinformatics/bth0 Efficient selection of unique and popular oligos for large EST databases Jie Zheng, Timothy J. Close, Tao Jiang and Stefano Lonardi,

More information

HP22.1 Roth Random Primer Kit A für die RAPD-PCR

HP22.1 Roth Random Primer Kit A für die RAPD-PCR HP22.1 Roth Random Kit A für die RAPD-PCR Kit besteht aus 20 Einzelprimern, jeweils aufgeteilt auf 2 Reaktionsgefäße zu je 1,0 OD Achtung: Angaben beziehen sich jeweils auf ein Reaktionsgefäß! Sequenz

More information

Genome Reconstruction: A Puzzle with a Billion Pieces. Phillip Compeau Carnegie Mellon University Computational Biology Department

Genome Reconstruction: A Puzzle with a Billion Pieces. Phillip Compeau Carnegie Mellon University Computational Biology Department http://cbd.cmu.edu Genome Reconstruction: A Puzzle with a Billion Pieces Phillip Compeau Carnegie Mellon University Computational Biology Department Eternity II: The Highest-Stakes Puzzle in History Courtesy:

More information

6 Anhang. 6.1 Transgene Su(var)3-9-Linien. P{GS.ry + hs(su(var)3-9)egfp} 1 I,II,III,IV 3 2I 3 3 I,II,III 3 4 I,II,III 2 5 I,II,III,IV 3

6 Anhang. 6.1 Transgene Su(var)3-9-Linien. P{GS.ry + hs(su(var)3-9)egfp} 1 I,II,III,IV 3 2I 3 3 I,II,III 3 4 I,II,III 2 5 I,II,III,IV 3 6.1 Transgene Su(var)3-9-n P{GS.ry + hs(su(var)3-9)egfp} 1 I,II,III,IV 3 2I 3 3 I,II,III 3 4 I,II,II 5 I,II,III,IV 3 6 7 I,II,II 8 I,II,II 10 I,II 3 P{GS.ry + UAS(Su(var)3-9)EGFP} A AII 3 B P{GS.ry + (10.5kbSu(var)3-9EGFP)}

More information

SUPPLEMENTARY INFORMATION. Systematic evaluation of CRISPR-Cas systems reveals design principles for genome editing in human cells

SUPPLEMENTARY INFORMATION. Systematic evaluation of CRISPR-Cas systems reveals design principles for genome editing in human cells SUPPLEMENTARY INFORMATION Systematic evaluation of CRISPR-Cas systems reveals design principles for genome editing in human cells Yuanming Wang 1,2,7, Kaiwen Ivy Liu 2,7, Norfala-Aliah Binte Sutrisnoh

More information

Appendix A. Example code output. Chapter 1. Chapter 3

Appendix A. Example code output. Chapter 1. Chapter 3 Appendix A Example code output This is a compilation of output from selected examples. Some of these examples requires exernal input from e.g. STDIN, for such examples the interaction with the program

More information

Supplementary Table 1. Data collection and refinement statistics

Supplementary Table 1. Data collection and refinement statistics Supplementary Table 1. Data collection and refinement statistics APY-EphA4 APY-βAla8.am-EphA4 Crystal Space group P2 1 P2 1 Cell dimensions a, b, c (Å) 36.27, 127.7, 84.57 37.22, 127.2, 84.6 α, β, γ (

More information

TCGR: A Novel DNA/RNA Visualization Technique

TCGR: A Novel DNA/RNA Visualization Technique TCGR: A Novel DNA/RNA Visualization Technique Donya Quick and Margaret H. Dunham Department of Computer Science and Engineering Southern Methodist University Dallas, Texas 75275 dquick@mail.smu.edu, mhd@engr.smu.edu

More information

Digging into acceptor splice site prediction: an iterative feature selection approach

Digging into acceptor splice site prediction: an iterative feature selection approach Digging into acceptor splice site prediction: an iterative feature selection approach Yvan Saeys, Sven Degroeve, and Yves Van de Peer Department of Plant Systems Biology, Ghent University, Flanders Interuniversity

More information

Graph Algorithms in Bioinformatics

Graph Algorithms in Bioinformatics Graph Algorithms in Bioinformatics Computational Biology IST Ana Teresa Freitas 2015/2016 Sequencing Clone-by-clone shotgun sequencing Human Genome Project Whole-genome shotgun sequencing Celera Genomics

More information

Machine Learning Classifiers

Machine Learning Classifiers Machine Learning Classifiers Outline Different types of learning problems Different types of learning algorithms Supervised learning Decision trees Naïve Bayes Perceptrons, Multi-layer Neural Networks

More information

Sequencing. Computational Biology IST Ana Teresa Freitas 2011/2012. (BACs) Whole-genome shotgun sequencing Celera Genomics

Sequencing. Computational Biology IST Ana Teresa Freitas 2011/2012. (BACs) Whole-genome shotgun sequencing Celera Genomics Computational Biology IST Ana Teresa Freitas 2011/2012 Sequencing Clone-by-clone shotgun sequencing Human Genome Project Whole-genome shotgun sequencing Celera Genomics (BACs) 1 Must take the fragments

More information

Sequence Assembly. BMI/CS 576 Mark Craven Some sequencing successes

Sequence Assembly. BMI/CS 576  Mark Craven Some sequencing successes Sequence Assembly BMI/CS 576 www.biostat.wisc.edu/bmi576/ Mark Craven craven@biostat.wisc.edu Some sequencing successes Yersinia pestis Cannabis sativa The sequencing problem We want to determine the identity

More information

DNA Sequencing. Overview

DNA Sequencing. Overview BINF 3350, Genomics and Bioinformatics DNA Sequencing Young-Rae Cho Associate Professor Department of Computer Science Baylor University Overview Backgrounds Eulerian Cycles Problem Hamiltonian Cycles

More information

warm-up exercise Representing Data Digitally goals for today proteins example from nature

warm-up exercise Representing Data Digitally goals for today proteins example from nature Representing Data Digitally Anne Condon September 6, 007 warm-up exercise pick two examples of in your everyday life* in what media are the is represented? is the converted from one representation to another,

More information

Sequence Assembly Required!

Sequence Assembly Required! Sequence Assembly Required! 1 October 3, ISMB 20172007 1 Sequence Assembly Genome Sequenced Fragments (reads) Assembled Contigs Finished Genome 2 Greedy solution is bounded 3 Typical assembly strategy

More information

10/8/13 Comp 555 Fall

10/8/13 Comp 555 Fall 10/8/13 Comp 555 Fall 2013 1 Find a tour crossing every bridge just once Leonhard Euler, 1735 Bridges of Königsberg 10/8/13 Comp 555 Fall 2013 2 Find a cycle that visits every edge exactly once Linear

More information

Genome 373: Genome Assembly. Doug Fowler

Genome 373: Genome Assembly. Doug Fowler Genome 373: Genome Assembly Doug Fowler What are some of the things we ve seen we can do with HTS data? We ve seen that HTS can enable a wide variety of analyses ranging from ID ing variants to genome-

More information

10/15/2009 Comp 590/Comp Fall

10/15/2009 Comp 590/Comp Fall Lecture 13: Graph Algorithms Study Chapter 8.1 8.8 10/15/2009 Comp 590/Comp 790-90 Fall 2009 1 The Bridge Obsession Problem Find a tour crossing every bridge just once Leonhard Euler, 1735 Bridges of Königsberg

More information

2 41L Tag- AA GAA AAA ATA AAA GCA TTA RYA GAA ATT TGT RMW GAR C K65 Tag- A AAT CCA TAC AAT ACT CCA GTA TTT GCY ATA AAG AA

2 41L Tag- AA GAA AAA ATA AAA GCA TTA RYA GAA ATT TGT RMW GAR C K65 Tag- A AAT CCA TAC AAT ACT CCA GTA TTT GCY ATA AAG AA 176 SUPPLEMENTAL TABLES 177 Table S1. ASPE Primers for HIV-1 group M subtype B Primer no Type a Sequence (5'-3') Tag ID b Position c 1 M41 Tag- AA GAA AAA ATA AAA GCA TTA RYA GAA ATT TGT RMW GAR A d 45

More information

Supplementary Data. Image Processing Workflow Diagram A - Preprocessing. B - Hough Transform. C - Angle Histogram (Rose Plot)

Supplementary Data. Image Processing Workflow Diagram A - Preprocessing. B - Hough Transform. C - Angle Histogram (Rose Plot) Supplementary Data Image Processing Workflow Diagram A - Preprocessing B - Hough Transform C - Angle Histogram (Rose Plot) D - Determination of holes Description of Image Processing Workflow The key steps

More information

Crick s Hypothesis Revisited: The Existence of a Universal Coding Frame

Crick s Hypothesis Revisited: The Existence of a Universal Coding Frame Crick s Hypothesis Revisited: The Existence of a Universal Coding Frame Jean-Louis Lassez*, Ryan A. Rossi Computer Science Department, Coastal Carolina University jlassez@coastal.edu, raross@coastal.edu

More information

Scalable Solutions for DNA Sequence Analysis

Scalable Solutions for DNA Sequence Analysis Scalable Solutions for DNA Sequence Analysis Michael Schatz Dec 4, 2009 JHU/UMD Joint Sequencing Meeting The Evolution of DNA Sequencing Year Genome Technology Cost 2001 Venter et al. Sanger (ABI) $300,000,000

More information

DNA Sequencing The Shortest Superstring & Traveling Salesman Problems Sequencing by Hybridization

DNA Sequencing The Shortest Superstring & Traveling Salesman Problems Sequencing by Hybridization Eulerian & Hamiltonian Cycle Problems DNA Sequencing The Shortest Superstring & Traveling Salesman Problems Sequencing by Hybridization The Bridge Obsession Problem Find a tour crossing every bridge just

More information

Algorithms for Bioinformatics

Algorithms for Bioinformatics Adapted from slides by Alexandru Tomescu, Leena Salmela and Veli Mäkinen, which are partly from http://bix.ucsd.edu/bioalgorithms/slides.php 582670 Algorithms for Bioinformatics Lecture 3: Graph Algorithms

More information

DNA Fragment Assembly

DNA Fragment Assembly Algorithms in Bioinformatics Sami Khuri Department of Computer Science San José State University San José, California, USA khuri@cs.sjsu.edu www.cs.sjsu.edu/faculty/khuri DNA Fragment Assembly Overlap

More information

Degenerate Coding and Sequence Compacting

Degenerate Coding and Sequence Compacting ESI The Erwin Schrödinger International Boltzmanngasse 9 Institute for Mathematical Physics A-1090 Wien, Austria Degenerate Coding and Sequence Compacting Maya Gorel Kirzhner V.M. Vienna, Preprint ESI

More information

Research Article Efficient Serial and Parallel Algorithms for Selection of Unique Oligos in EST Databases

Research Article Efficient Serial and Parallel Algorithms for Selection of Unique Oligos in EST Databases Advances in Bioinformatics Volume 03, Article ID 79330, 6 pages http://dx.doi.org/0.55/03/79330 Research Article Efficient Serial and Parallel Algorithms for Selection of Unique Oligos in EST Databases

More information

CSCI2950-C Lecture 4 DNA Sequencing and Fragment Assembly

CSCI2950-C Lecture 4 DNA Sequencing and Fragment Assembly CSCI2950-C Lecture 4 DNA Sequencing and Fragment Assembly Ben Raphael Sept. 22, 2009 http://cs.brown.edu/courses/csci2950-c/ l-mer composition Def: Given string s, the Spectrum ( s, l ) is unordered multiset

More information

de novo assembly Simon Rasmussen 36626: Next Generation Sequencing analysis DTU Bioinformatics Next Generation Sequencing Analysis

de novo assembly Simon Rasmussen 36626: Next Generation Sequencing analysis DTU Bioinformatics Next Generation Sequencing Analysis de novo assembly Simon Rasmussen 36626: Next Generation Sequencing analysis DTU Bioinformatics 27626 - Next Generation Sequencing Analysis Generalized NGS analysis Data size Application Assembly: Compare

More information

A relation between trinucleotide comma-free codes and trinucleotide circular codes

A relation between trinucleotide comma-free codes and trinucleotide circular codes Theoretical Computer Science 401 (2008) 17 26 www.elsevier.com/locate/tcs A relation between trinucleotide comma-free codes and trinucleotide circular codes Christian J. Michel a,, Giuseppe Pirillo b,c,

More information

Sequencing. Short Read Alignment. Sequencing. Paired-End Sequencing 6/10/2010. Tobias Rausch 7 th June 2010 WGS. ChIP-Seq. Applied Biosystems.

Sequencing. Short Read Alignment. Sequencing. Paired-End Sequencing 6/10/2010. Tobias Rausch 7 th June 2010 WGS. ChIP-Seq. Applied Biosystems. Sequencing Short Alignment Tobias Rausch 7 th June 2010 WGS RNA-Seq Exon Capture ChIP-Seq Sequencing Paired-End Sequencing Target genome Fragments Roche GS FLX Titanium Illumina Applied Biosystems SOLiD

More information

BLAST & Genome assembly

BLAST & Genome assembly BLAST & Genome assembly Solon P. Pissis Tomáš Flouri Heidelberg Institute for Theoretical Studies May 15, 2014 1 BLAST What is BLAST? The algorithm 2 Genome assembly De novo assembly Mapping assembly 3

More information

Purpose of sequence assembly

Purpose of sequence assembly Sequence Assembly Purpose of sequence assembly Reconstruct long DNA/RNA sequences from short sequence reads Genome sequencing RNA sequencing for gene discovery Amplicon sequencing But not for transcript

More information

LABORATORY STANDARD OPERATING PROCEDURE FOR PULSENET CODE: PNL28 MLVA OF SHIGA TOXIN-PRODUCING ESCHERICHIA COLI

LABORATORY STANDARD OPERATING PROCEDURE FOR PULSENET CODE: PNL28 MLVA OF SHIGA TOXIN-PRODUCING ESCHERICHIA COLI 1. PURPOSE: to describe the standardized laboratory protocol for molecular subtyping of Shiga toxin-producing Escherichia coli O157 (STEC O157) and Salmonella enterica serotypes Typhimurium and Enteritidis.

More information

Computational Architecture of Cloud Environments Michael Schatz. April 1, 2010 NHGRI Cloud Computing Workshop

Computational Architecture of Cloud Environments Michael Schatz. April 1, 2010 NHGRI Cloud Computing Workshop Computational Architecture of Cloud Environments Michael Schatz April 1, 2010 NHGRI Cloud Computing Workshop Cloud Architecture Computation Input Output Nebulous question: Cloud computing = Utility computing

More information

BIOINFORMATICS APPLICATIONS NOTE

BIOINFORMATICS APPLICATIONS NOTE BIOINFORMATICS APPLICATIONS NOTE Sequence analysis BRAT: Bisulfite-treated Reads Analysis Tool (Supplementary Methods) Elena Y. Harris 1,*, Nadia Ponts 2, Aleksandr Levchuk 3, Karine Le Roch 2 and Stefano

More information

How to Run NCBI BLAST on zcluster at GACRC

How to Run NCBI BLAST on zcluster at GACRC How to Run NCBI BLAST on zcluster at GACRC BLAST: Basic Local Alignment Search Tool Georgia Advanced Computing Resource Center University of Georgia Suchitra Pakala pakala@uga.edu 1 OVERVIEW What is BLAST?

More information

BLAST. Basic Local Alignment Search Tool. Used to quickly compare a protein or DNA sequence to a database.

BLAST. Basic Local Alignment Search Tool. Used to quickly compare a protein or DNA sequence to a database. BLAST Basic Local Alignment Search Tool Used to quickly compare a protein or DNA sequence to a database. There is no such thing as a free lunch BLAST is fast and highly sensitive compared to competitors.

More information

de Bruijn graphs for sequencing data

de Bruijn graphs for sequencing data de Bruijn graphs for sequencing data Rayan Chikhi CNRS Bonsai team, CRIStAL/INRIA, Univ. Lille 1 SMPGD 2016 1 MOTIVATION - de Bruijn graphs are instrumental for reference-free sequencing data analysis:

More information

Supplementary Materials:

Supplementary Materials: Supplementary Materials: Amino acid codo n Numb er Table S1. Codon usage in all the protein coding genes. RSC U Proportion (%) Amino acid codo n Numb er RSC U Proportion (%) Phe UUU 861 1.31 5.71 Ser UCU

More information

Algorithms for Bioinformatics

Algorithms for Bioinformatics Adapted from slides by Alexandru Tomescu, Leena Salmela and Veli Mäkinen, which are partly from http://bix.ucsd.edu/bioalgorithms/slides.php 58670 Algorithms for Bioinformatics Lecture 5: Graph Algorithms

More information

Graph Algorithms in Bioinformatics

Graph Algorithms in Bioinformatics Graph Algorithms in Bioinformatics Bioinformatics: Issues and Algorithms CSE 308-408 Fall 2007 Lecture 13 Lopresti Fall 2007 Lecture 13-1 - Outline Introduction to graph theory Eulerian & Hamiltonian Cycle

More information

Assembly in the Clouds

Assembly in the Clouds Assembly in the Clouds Michael Schatz October 13, 2010 Beyond the Genome Shredded Book Reconstruction Dickens accidentally shreds the first printing of A Tale of Two Cities Text printed on 5 long spools

More information

Genome 373: Mapping Short Sequence Reads I. Doug Fowler

Genome 373: Mapping Short Sequence Reads I. Doug Fowler Genome 373: Mapping Short Sequence Reads I Doug Fowler Two different strategies for parallel amplification BRIDGE PCR EMULSION PCR Two different strategies for parallel amplification BRIDGE PCR EMULSION

More information

MLiB - Mandatory Project 2. Gene finding using HMMs

MLiB - Mandatory Project 2. Gene finding using HMMs MLiB - Mandatory Project 2 Gene finding using HMMs Viterbi decoding >NC_002737.1 Streptococcus pyogenes M1 GAS TTGTTGATATTCTGTTTTTTCTTTTTTAGTTTTCCACATGAAAAATAGTTGAAAACAATA GCGGTGTCCCCTTAAAATGGCTTTTCCACAGGTTGTGGAGAACCCAAATTAACAGTGTTA

More information

Detecting Superbubbles in Assembly Graphs. Taku Onodera (U. Tokyo)! Kunihiko Sadakane (NII)! Tetsuo Shibuya (U. Tokyo)!

Detecting Superbubbles in Assembly Graphs. Taku Onodera (U. Tokyo)! Kunihiko Sadakane (NII)! Tetsuo Shibuya (U. Tokyo)! Detecting Superbubbles in Assembly Graphs Taku Onodera (U. Tokyo)! Kunihiko Sadakane (NII)! Tetsuo Shibuya (U. Tokyo)! de Bruijn Graph-based Assembly Reads (substrings of original DNA sequence) de Bruijn

More information

Omega: an Overlap-graph de novo Assembler for Metagenomics

Omega: an Overlap-graph de novo Assembler for Metagenomics Omega: an Overlap-graph de novo Assembler for Metagenomics B a h l e l H a i d e r, Ta e - H y u k A h n, B r i a n B u s h n e l l, J u a n j u a n C h a i, A l e x C o p e l a n d, C h o n g l e Pa n

More information

arxiv: v1 [cs.db] 30 Sep 2011

arxiv: v1 [cs.db] 30 Sep 2011 ERA: Efficient Serial and Parallel Suffix Tree Construction for Very Long Strings arxiv:1109.6884v1 [cs.db] 30 Sep 2011 Essam Mansour 1 Amin Allam 1 1 Math. & Computer Sciences and Engineering King Abdullah

More information

Meraculous De Novo Assembly of the Ariolimax dolichophallus Genome. Charles Cole, Jake Houser, Kyle McGovern, and Jennie Richardson

Meraculous De Novo Assembly of the Ariolimax dolichophallus Genome. Charles Cole, Jake Houser, Kyle McGovern, and Jennie Richardson Meraculous De Novo Assembly of the Ariolimax dolichophallus Genome Charles Cole, Jake Houser, Kyle McGovern, and Jennie Richardson Meraculous Assembler Published by the US Department of Energy Joint Genome

More information

Preliminary Syllabus. Genomics. Introduction & Genome Assembly Sequence Comparison Gene Modeling Gene Function Identification

Preliminary Syllabus. Genomics. Introduction & Genome Assembly Sequence Comparison Gene Modeling Gene Function Identification Preliminary Syllabus Sep 30 Oct 2 Oct 7 Oct 9 Oct 14 Oct 16 Oct 21 Oct 25 Oct 28 Nov 4 Nov 8 Introduction & Genome Assembly Sequence Comparison Gene Modeling Gene Function Identification OCTOBER BREAK

More information

Algorithms and Data Structures

Algorithms and Data Structures Algorithms and Data Structures Sorting beyond Value Comparisons Marius Kloft Content of this Lecture Radix Exchange Sort Sorting bitstrings in linear time (almost) Bucket Sort Marius Kloft: Alg&DS, Summer

More information

Parallel de novo Assembly of Complex (Meta) Genomes via HipMer

Parallel de novo Assembly of Complex (Meta) Genomes via HipMer Parallel de novo Assembly of Complex (Meta) Genomes via HipMer Aydın Buluç Computational Research Division, LBNL May 23, 2016 Invited Talk at HiCOMB 2016 Outline and Acknowledgments Joint work (alphabetical)

More information

RESEARCH TOPIC IN BIOINFORMANTIC

RESEARCH TOPIC IN BIOINFORMANTIC RESEARCH TOPIC IN BIOINFORMANTIC GENOME ASSEMBLY Instructor: Dr. Yufeng Wu Noted by: February 25, 2012 Genome Assembly is a kind of string sequencing problems. As we all know, the human genome is very

More information

BLAST & Genome assembly

BLAST & Genome assembly BLAST & Genome assembly Solon P. Pissis Tomáš Flouri Heidelberg Institute for Theoretical Studies November 17, 2012 1 Introduction Introduction 2 BLAST What is BLAST? The algorithm 3 Genome assembly De

More information

Hybrid Parallel Programming

Hybrid Parallel Programming Hybrid Parallel Programming for Massive Graph Analysis KameshMdd Madduri KMadduri@lbl.gov ComputationalResearch Division Lawrence Berkeley National Laboratory SIAM Annual Meeting 2010 July 12, 2010 Hybrid

More information

Indexing and Searching

Indexing and Searching Indexing and Searching Introduction How to retrieval information? A simple alternative is to search the whole text sequentially Another option is to build data structures over the text (called indices)

More information

B L A S T! BLAST: Basic local alignment search tool. Copyright notice. February 6, Pairwise alignment: key points. Outline of tonight s lecture

B L A S T! BLAST: Basic local alignment search tool. Copyright notice. February 6, Pairwise alignment: key points. Outline of tonight s lecture February 6, 2008 BLAST: Basic local alignment search tool B L A S T! Jonathan Pevsner, Ph.D. Introduction to Bioinformatics pevsner@jhmi.edu 4.633.0 Copyright notice Many of the images in this powerpoint

More information

Study of Data Localities in Suffix-Tree Based Genetic Algorithms

Study of Data Localities in Suffix-Tree Based Genetic Algorithms Study of Data Localities in Suffix-Tree Based Genetic Algorithms Carl I. Bergenhem, Michael T. Smith Abstract. This paper focuses on the study of cache localities of two genetic algorithms based on the

More information

debgr: An Efficient and Near-Exact Representation of the Weighted de Bruijn Graph Prashant Pandey Stony Brook University, NY, USA

debgr: An Efficient and Near-Exact Representation of the Weighted de Bruijn Graph Prashant Pandey Stony Brook University, NY, USA debgr: An Efficient and Near-Exact Representation of the Weighted de Bruijn Graph Prashant Pandey Stony Brook University, NY, USA De Bruijn graphs are ubiquitous [Pevzner et al. 2001, Zerbino and Birney,

More information

Problem statement. CS267 Assignment 3: Parallelize Graph Algorithms for de Novo Genome Assembly. Spring Example.

Problem statement. CS267 Assignment 3: Parallelize Graph Algorithms for de Novo Genome Assembly. Spring Example. CS267 Assignment 3: Problem statement 2 Parallelize Graph Algorithms for de Novo Genome Assembly k-mers are sequences of length k (alphabet is A/C/G/T). An extension is a simple symbol (A/C/G/T/F). The

More information

High-Performance Graph Traversal for De Bruijn Graph-Based Metagenome Assembly

High-Performance Graph Traversal for De Bruijn Graph-Based Metagenome Assembly 1 / 32 High-Performance Graph Traversal for De Bruijn Graph-Based Metagenome Assembly Vasudevan Rengasamy Kamesh Madduri School of EECS The Pennsylvania State University {vxr162, madduri}@psu.edu SIAM

More information

DNA Fragment Assembly

DNA Fragment Assembly SIGCSE 009 Algorithms in Bioinformatics Sami Khuri Department of Computer Science San José State University San José, California, USA khuri@cs.sjsu.edu www.cs.sjsu.edu/faculty/khuri DNA Fragment Assembly

More information

NOSEP: Non-Overlapping Sequence Pattern Mining with Gap Constraints

NOSEP: Non-Overlapping Sequence Pattern Mining with Gap Constraints 1 NOSEP: Non-Overlapping Sequence Pattern Mining with Gap Constraints Youxi Wu, Yao Tong, Xingquan Zhu, Senior, IEEE, and Xindong Wu, Fellow, IEEE Abstract Sequence pattern mining aims to discover frequent

More information

Michał Kierzynka et al. Poznan University of Technology. 17 March 2015, San Jose

Michał Kierzynka et al. Poznan University of Technology. 17 March 2015, San Jose Michał Kierzynka et al. Poznan University of Technology 17 March 2015, San Jose The research has been supported by grant No. 2012/05/B/ST6/03026 from the National Science Centre, Poland. DNA de novo assembly

More information

Bioinformatics I, WS 09-10, D. Huson, February 10,

Bioinformatics I, WS 09-10, D. Huson, February 10, Bioinformatics I, WS 09-10, D. Huson, February 10, 2010 189 12 More on Suffix Trees This week we study the following material: WOTD-algorithm MUMs finding repeats using suffix trees 12.1 The WOTD Algorithm

More information

Read Mapping and Assembly

Read Mapping and Assembly Statistical Bioinformatics: Read Mapping and Assembly Stefan Seemann seemann@rth.dk University of Copenhagen April 9th 2019 Why sequencing? Why sequencing? Which organism does the sample comes from? Assembling

More information

Application of the BWT Method to Solve the Exact String Matching Problem

Application of the BWT Method to Solve the Exact String Matching Problem Application of the BWT Method to Solve the Exact String Matching Problem T. W. Chen and R. C. T. Lee Department of Computer Science National Tsing Hua University, Hsinchu, Taiwan chen81052084@gmail.com

More information

I519 Introduction to Bioinformatics, Genome assembly. Yuzhen Ye School of Informatics & Computing, IUB

I519 Introduction to Bioinformatics, Genome assembly. Yuzhen Ye School of Informatics & Computing, IUB I519 Introduction to Bioinformatics, 2014 Genome assembly Yuzhen Ye (yye@indiana.edu) School of Informatics & Computing, IUB Contents Genome assembly problem Approaches Comparative assembly The string

More information

ngaio.)' Thif. as you ore doubtless aware U the

ngaio.)' Thif. as you ore doubtless aware U the c G c2 VV VV $60 c V X G Y Y 4 4 2 G F cg V c / g q c c c g c c c g c c g c c c cg VY gc c //Y 0 G!«> ] gc g 25 c Y g) g! c cg c c X c c 5 Y g g F g F g F «g c 3 x «(c X c! c c c g F VG ) g < c c c c g

More information

Cse634 DATA MINING TEST REVIEW. Professor Anita Wasilewska Computer Science Department Stony Brook University

Cse634 DATA MINING TEST REVIEW. Professor Anita Wasilewska Computer Science Department Stony Brook University Cse634 DATA MINING TEST REVIEW Professor Anita Wasilewska Computer Science Department Stony Brook University Preprocessing stage Preprocessing: includes all the operations that have to be performed before

More information

Phylogenetics on CUDA (Parallel) Architectures Bradly Alicea

Phylogenetics on CUDA (Parallel) Architectures Bradly Alicea Descent w/modification Descent w/modification Descent w/modification Descent w/modification CPU Descent w/modification Descent w/modification Phylogenetics on CUDA (Parallel) Architectures Bradly Alicea

More information

Computational Methods for de novo Assembly of Next-Generation Genome Sequencing Data

Computational Methods for de novo Assembly of Next-Generation Genome Sequencing Data 1/39 Computational Methods for de novo Assembly of Next-Generation Genome Sequencing Data Rayan Chikhi ENS Cachan Brittany / IRISA (Genscale team) Advisor : Dominique Lavenier 2/39 INTRODUCTION, YEAR 2000

More information

String Matching. Pedro Ribeiro 2016/2017 DCC/FCUP. Pedro Ribeiro (DCC/FCUP) String Matching 2016/ / 42

String Matching. Pedro Ribeiro 2016/2017 DCC/FCUP. Pedro Ribeiro (DCC/FCUP) String Matching 2016/ / 42 String Matching Pedro Ribeiro DCC/FCUP 2016/2017 Pedro Ribeiro (DCC/FCUP) String Matching 2016/2017 1 / 42 On this lecture The String Matching Problem Naive Algorithm Deterministic Finite Automata Knuth-Morris-Pratt

More information

Evaluation of Relational Operations: Other Techniques

Evaluation of Relational Operations: Other Techniques Evaluation of Relational Operations: Other Techniques Chapter 14, Part B Database Management Systems 3ed, R. Ramakrishnan and Johannes Gehrke 1 Using an Index for Selections Cost depends on #qualifying

More information

SAPLING: Suffix Array Piecewise Linear INdex for Genomics Michael Kirsche

SAPLING: Suffix Array Piecewise Linear INdex for Genomics Michael Kirsche SAPLING: Suffix Array Piecewise Linear INdex for Genomics Michael Kirsche mkirsche@jhu.edu StringBio 2018 Outline Substring Search Problem Caching and Learned Data Structures Methods Results Ongoing work

More information

An Efficient Algorithm for Finding Similar Short Substrings from Large Scale String Data

An Efficient Algorithm for Finding Similar Short Substrings from Large Scale String Data An Efficient Algorithm for Finding Similar Short Substrings from Large Scale String Data Takeaki Uno uno@nii.jp, National Institute of Informatics 2-1-2, Hitotsubashi, Chiyoda-ku, Tokyo 101-8430, Japan

More information

COMP 204: Dictionaries Recap & Sets

COMP 204: Dictionaries Recap & Sets COMP 204: Dictionaries Recap & Sets Material from Carlos G. Oliver, Christopher J.F. Cameron October 10, 2018 1/21 Reminder Midterm on Wednesday October 17 at 6:30-8:00 pm. Assignment 2: numpy is allowed

More information

Clustering Billions of Images with Large Scale Nearest Neighbor Search

Clustering Billions of Images with Large Scale Nearest Neighbor Search Clustering Billions of Images with Large Scale Nearest Neighbor Search Ting Liu, Charles Rosenberg, Henry A. Rowley IEEE Workshop on Applications of Computer Vision February 2007 Presented by Dafna Bitton

More information

11/5/13 Comp 555 Fall

11/5/13 Comp 555 Fall 11/5/13 Comp 555 Fall 2013 1 Example of repeats: ATGGTCTAGGTCCTAGTGGTC Motivation to find them: Phenotypes arise from copy-number variations Genomic rearrangements are often associated with repeats Trace

More information

(for more info see:

(for more info see: Genome assembly (for more info see: http://www.cbcb.umd.edu/research/assembly_primer.shtml) Introduction Sequencing technologies can only "read" short fragments from a genome. Reconstructing the entire

More information

Shotgun sequencing. Coverage is simply the average number of reads that overlap each true base in genome.

Shotgun sequencing. Coverage is simply the average number of reads that overlap each true base in genome. Shotgun sequencing Genome (unknown) Reads (randomly chosen; have errors) Coverage is simply the average number of reads that overlap each true base in genome. Here, the coverage is ~10 just draw a line

More information

Special course in Computer Science: Advanced Text Algorithms

Special course in Computer Science: Advanced Text Algorithms Special course in Computer Science: Advanced Text Algorithms Lecture 5: Suffix trees and their applications Elena Czeizler and Ion Petre Department of IT, Abo Akademi Computational Biomodelling Laboratory

More information

OFFICE OF RESEARCH AND SPONSORED PROGRAMS

OFFICE OF RESEARCH AND SPONSORED PROGRAMS OFFICE OF RESEARCH AND SPONSORED PROGRAMS June 9, 2016 Mr. Satoshi Harada Department of Innovation Research Japan Science and Technology Agency (JST) K s Gobancho, 7, Gobancho, Chiyoda-ku, Tokyo, 102-0076

More information

Evaluation of Relational Operations: Other Techniques

Evaluation of Relational Operations: Other Techniques Evaluation of Relational Operations: Other Techniques [R&G] Chapter 14, Part B CS4320 1 Using an Index for Selections Cost depends on #qualifying tuples, and clustering. Cost of finding qualifying data

More information

Implementation of Relational Operations: Other Operations

Implementation of Relational Operations: Other Operations Implementation of Relational Operations: Other Operations Module 4, Lecture 2 Database Management Systems, R. Ramakrishnan 1 Simple Selections SELECT * FROM Reserves R WHERE R.rname < C% Of the form σ

More information

As of August 15, 2008, GenBank contained bases from reported sequences. The search procedure should be

As of August 15, 2008, GenBank contained bases from reported sequences. The search procedure should be 48 Bioinformatics I, WS 09-10, S. Henz (script by D. Huson) November 26, 2009 4 BLAST and BLAT Outline of the chapter: 1. Heuristics for the pairwise local alignment of two sequences 2. BLAST: search and

More information

de novo assembly Rayan Chikhi Pennsylvania State University Workshop On Genomics - Cesky Krumlov - January /73

de novo assembly Rayan Chikhi Pennsylvania State University Workshop On Genomics - Cesky Krumlov - January /73 1/73 de novo assembly Rayan Chikhi Pennsylvania State University Workshop On Genomics - Cesky Krumlov - January 2014 2/73 YOUR INSTRUCTOR IS.. - Postdoc at Penn State, USA - PhD at INRIA / ENS Cachan,

More information

Indexing Variable Length Substrings for Exact and Approximate Matching

Indexing Variable Length Substrings for Exact and Approximate Matching Indexing Variable Length Substrings for Exact and Approximate Matching Gonzalo Navarro 1, and Leena Salmela 2 1 Department of Computer Science, University of Chile gnavarro@dcc.uchile.cl 2 Department of

More information

TCCAGGTG-GAT TGCAAGTGCG-T. Local Sequence Alignment & Heuristic Local Aligners. Review: Probabilistic Interpretation. Chance or true homology?

TCCAGGTG-GAT TGCAAGTGCG-T. Local Sequence Alignment & Heuristic Local Aligners. Review: Probabilistic Interpretation. Chance or true homology? Local Sequence Alignment & Heuristic Local Aligners Lectures 18 Nov 28, 2011 CSE 527 Computational Biology, Fall 2011 Instructor: Su-In Lee TA: Christopher Miles Monday & Wednesday 12:00-1:20 Johnson Hall

More information

Sequence Design Problems in Discovery of Regulatory Elements

Sequence Design Problems in Discovery of Regulatory Elements Sequence Design Problems in Discovery of Regulatory Elements Yaron Orenstein, Bonnie Berger and Ron Shamir Regulatory Genomics workshop Simons Institute March 10th, 2016, Berkeley, CA Differentially methylated

More information

Database Applications (15-415)

Database Applications (15-415) Database Applications (15-415) DBMS Internals- Part VI Lecture 17, March 24, 2015 Mohammad Hammoud Today Last Two Sessions: DBMS Internals- Part V External Sorting How to Start a Company in Five (maybe

More information

NextGenMap and the impact of hhighly polymorphic regions. Arndt von Haeseler

NextGenMap and the impact of hhighly polymorphic regions. Arndt von Haeseler NextGenMap and the impact of hhighly polymorphic regions Arndt von Haeseler Joint work with: The Technological Revolution Wetterstrand KA. DNA Sequencing Costs: Data from the NHGRI Genome Sequencing Program

More information

A Novel Implementation of an Extended 8x8 Playfair Cipher Using Interweaving on DNA-encoded Data

A Novel Implementation of an Extended 8x8 Playfair Cipher Using Interweaving on DNA-encoded Data International Journal of Electrical and Computer Engineering (IJECE) Vol. 4, No. 1, Feburary 2014, pp. 93~100 ISSN: 2088-8708 93 A Novel Implementation of an Extended 8x8 Playfair Cipher Using Interweaving

More information

Sequencing Alignment I

Sequencing Alignment I Sequencing Alignment I Lectures 16 Nov 21, 2011 CSE 527 Computational Biology, Fall 2011 Instructor: Su-In Lee TA: Christopher Miles Monday & Wednesday 12:00-1:20 Johnson Hall (JHN) 022 1 Outline: Sequence

More information

Evaluation of Relational Operations: Other Techniques

Evaluation of Relational Operations: Other Techniques Evaluation of Relational Operations: Other Techniques Chapter 12, Part B Database Management Systems 3ed, R. Ramakrishnan and Johannes Gehrke 1 Using an Index for Selections v Cost depends on #qualifying

More information

Scrible: Ultra-Accurate Error-Correction of Pooled Sequenced Reads

Scrible: Ultra-Accurate Error-Correction of Pooled Sequenced Reads Scrible: Ultra-Accurate Error-Correction of Pooled Sequenced Reads Denise Duma 1, Francesca Cordero 4, Marco Beccuti 4, Gianfranco Ciardo 5, Timothy J. Close 2, and Stefano Lonardi 2 1 Baylor College of

More information