From reads to results: differen1al expression analysis with RNA seq. Alicia Oshlack Bioinforma1cs Division Walter and Eliza Hall Ins1tute

Size: px
Start display at page:

Download "From reads to results: differen1al expression analysis with RNA seq. Alicia Oshlack Bioinforma1cs Division Walter and Eliza Hall Ins1tute"

Transcription

1 From reads to results: differen1al expression analysis with RNA seq Alicia Oshlack Bioinforma1cs Division Walter and Eliza Hall Ins1tute

2 Purported benefits and opportuni1es of RNA seq All transcripts are sequenced not just ones for which probes are designed (cf microarrays) Annota1on of new exons, transcribed regions, genes or non coding RNAs No cross hybridiza1on Comparison of expression between genes Detec1on of low abundance transcripts Whole transcriptome sequencing The ability to look at alterna1ve splicing Allele specific expression RNA edi1ng

3 This talk Analysis of RNA seq data for the purpose of determining differen1al expression How much are expression levels changing between samples?

4 RNA seq Pepke et al, Nature Methods, 2009

5 Raw data Short sequence reads Quality scores

6 RNA seq analysis steps Raw sequence reads Map onto genome Summarize to genes/transcripts Sta1s1cal tes1ng: Determine differen1ally expressed genes Systems biology

7 Mapping: RNA seq

8 Sequencing transcripts not the genome Gene CDS CDS CDS CDS transcript CDS CDS CDS CDS

9 Specific issues for RNA seq Unlike ChIP seq or DNA seq, with RNA seq we really want to align to the transcriptome. The transcriptome is built from the genome, but exon boundary or junc1on reads will not align to the genome. The longer the reads, the more likely a read is to hit a junc1on. This can be avoided by using a clever reference.

10 The problem Hammer et al, Genome Research, 2010

11 Op1on 1: Don t worry about it! Map to genome. Captures any reads in unannotated exons. Can t map any reads that cross exon boundaries. Not dependent on any annota1on.

12 Op1on 2: Build a junc1on library Make a new reference by combining all known exons. Captures some junc1on reads. Biased towards well annotated genes. Mapping to the transcriptome is just a special junc1on library.

13 Op1on 3: De novo transcriptome Can be truly de novo by assembling transcripts without a reference, but this is not usually what we mean. More ocen we try and determine where splice junc1ons occur using the data itself. Computa1onally intensive, but unbiased by annota1on. Several socware packages to do this such as TopHat, SplitSeek,

14 A common approach Ini1ally map to genome Align unmapped reads to a junc1on library Align further unmapped reads to polya tail

15 RNA seq analysis steps Raw sequence reads Map onto genome Summarize to genes/transcripts Sta1s1cal tes1ng: Determine differen1ally expressed genes Systems biology

16 Summariza1on

17 CDS CDS CDS CDS Coding Sequence Exons Introns Splice Junc1ons Reads in exons Exons + junc1ons All reads start to end of transcript De novo methods

18 Table of counts gene Sample A Sample A Sample B Sample B A B C D E F G H I J K L

19 RNA seq analysis steps Raw sequence reads Map onto genome Summarize to genes/transcripts Sta1s1cal tes1ng: Determine differen1ally expressed genes Systems biology

20 Normaliza1on Removing technical sources of varia1on

21 Simple thought experiment Two samples A and B, sequenced to the same depth (same library size) Every gene that is expressed in A, is expressed in B at the same level Say there are a small number of genes that are expressed uniquely to sample B, but they are quite highly expressed (lots of reads) Many genes within the common set will appear differen1ally expressed (B < A)

22 Another way to view it Hypothe1cal example: Sequence 6 libraries to the same depth, with varying levels of uniqueto sample expression Differences in observed counts among the common genes Red=low, goldenyellow=high

23 Marioni et al RNA seq data 5 lanes of liver RNA, 5 lanes of kidney RNA Compare two single kidney libraries (technical replicates), acer adjus1ng for library size trimmed mean Distribu1on of log ra1os of counts M = library size 0 counts are omiped Red line = trimmed mean

24 Marioni et al RNA seq data 5 lanes of liver RNA, 5 lanes of kidney RNA Compare one liver to one kidney library, acer adjus1ng for library size trimmed mean Distribu1on of log ra1os of counts M = library size 0 counts are omiped Red line = trimmed mean

25 Should we expect the log ra1o to be 0 acer normaliza1on? I would argue: yes. Another way to look at it: M vs A plots trimmed mean

26 Should we expect the log ra1o to be 0 acer normaliza1on? Housekeeping genes shown in blue. Trimmed mean Median of 545 housekeeping genes [from Eisenberg and Levanon (2003), Trends in Gene1cs]

27 Shic in log ra1os is caused by RNA composi1on Sequencing real estate is fixed. Underlying RNA composi1on can be very different e.g. several liverspecific genes An adjustment at the analysis stage should be made

28 The adjustment to data analysis is straighsorward Assump1on: core set of genes that do not change in expression. Pick a reference sample, compute TMM rela1ve to reference TMM (Trimmed Mean of M values) M=log ra1o Adjustment to sta1s1cal analysis: Use addi1onal offset (GLM) Use effec1ve library size (Fisher s exact test)

29 Differen1al expression Sta1s1cal tes1ng for differences in expression level Several methods available edger next talk List of DE genes

30 RNA seq analysis steps Raw sequence reads Map onto genome Summarize to genes/transcripts Sta1s1cal tes1ng: Determine differen1ally expressed genes Systems biology

31 Going beyond gene lists Gene length bias and GO analysis

32 Sequencing the whole transcript RNA fragmenta1on

33 Length bias in RNA seq Equal number of transcripts 6X length 6X number of fragments More power to detect DE at a given threshold For genes of the same expression level longer transcripts will have more reads Therefore there is more informa1on for longer transcripts than shorter ones Longer genes have higher power to detect DE This length bias should not be present for microarrays

34 Propor1on of DE genes

35 Gene Ontology analysis Gene Ontology categorises genes into func1onal groups We wish to know if certain gene ontologies have more DE genes than expected If a category has lots of long genes we expect it to have more DE genes Can t use simple sta1s1cal tests

36 Aim Develop a computa1onal method for gene category tes1ng that can account for gene level biases in differen1al expression detec1on Category tes1ng refers to tes1ng if a set of genes has an over representa1on of DE genes

37 Three step procedure 1. Determine which genes are differen1ally expressed 2. Define a probability weigh1ng func1on 3. Generate many random samples to produce a null distribu1on in order to calculate significance of a category

38 Probability weigh1ng func1on Fit a func1on to the binary data series 1=DE, 0=!DE We chose a spline with a monotonicity requirement

39 Random sampling Select a random set of genes the same size as the set of DE genes However the probability of selec1ng a gene is weighted by the value of the probability weigh1ng func1on (based on the length or read count of the gene) Then count how many genes in the DE set have the GO category of interest Repeat this many 1mes Calculate a p value for the category

40 Results Categories with short genes get a higher rank in GOseq Categories with long genes get a lower rank

41 Even for a small number of categories there are a significant number of discrepancies between the methods. Over all 20% different

42 The GOseq func1on A func1on has been wripen in R to perform the category tests Input: gene iden1fiers and which genes are differen1ally expressed Output: GO categories with p values Can also use your own categories

43 Systems Biology: Integra1ng data Gene expression ChIP seq Transcrip1on factors Histone modifica1ons Epigene1c data Genome sequencing Copy number SNPs

44 Overview of analysis Mapping Millions of short reads Burrows Wheeler Transform Bow e, BWA, SOAP2 Hash-tables PerM, SHRiMP, BFAST, ELAND Unmapped reads Map to Junc on library created from annota on. Summarization Reads aligned to reference Map to de novo junc on library. SplitSeek, Tophat, SOAPals By Coding Sequence. By Exon. By Gene span. Junc on reads. Table of counts Normalization Between sample. TMM, upper quar le DE testing Poisson test. DEGseg Within sample. RPKM, quan le Nega ve binomial test. edger, bayseq, DEseq List of Differen ally Expressed genes Systems Biology Test for enriched categories/pathways. GOseq Infer networks and integrate with other data Biological insight

45 The future Capacity is increasing Analysis methodology is cri1cal Integra1on of different types of data Opportuni1es to use this data in new and imagina1ve ways

46 Acknowledgements Mark Robinson Maphew Young Maphew Wakefield Gordon Smyth Terry Speed Maphew Ritchie Natalie Thorne Davis McCarthy

From reads to results: differential. Alicia Oshlack Head of Bioinformatics

From reads to results: differential. Alicia Oshlack Head of Bioinformatics From reads to results: differential expression analysis with ihrna seq Alicia Oshlack Head of Bioinformatics Murdoch Childrens Research Institute Benefits and opportunities ii of RNA seq All transcripts

More information

RNA sequencing Integra1ve Genomics module

RNA sequencing Integra1ve Genomics module RNA sequencing Integra1ve Genomics module Michael Inouye Centre for Systems Genomics University of Melbourne, Australia Summer Ins@tute in Sta@s@cal Gene@cs 2016 SeaBle, USA @minouye271 inouyelab.org This

More information

RNA Seq: Methods and Applica6ons. Prat Thiru

RNA Seq: Methods and Applica6ons. Prat Thiru RNA Seq: Methods and Applica6ons Prat Thiru 1 Outline Intro to RNA Seq Biological Ques6ons Comparison with Other Methods RNA Seq Protocol RNA Seq Applica6ons Annota6on Quan6fica6on Other Applica6ons Expression

More information

High performance sequencing and gene expression quantification

High performance sequencing and gene expression quantification High performance sequencing and gene expression quantification Ana Conesa Genomics of Gene Expression Lab Centro de Investigaciones Príncipe Felipe Valencia aconesa@cipf.es Next Generation Sequencing NGS

More information

RNA Ribonucleic Acid. Week 14, Lecture 28. RNA- seq is a new, emerging field. Two major domains applica:on 12/4/ When the transcriptome is known

RNA Ribonucleic Acid. Week 14, Lecture 28. RNA- seq is a new, emerging field. Two major domains applica:on 12/4/ When the transcriptome is known 2014 - BMMB 852D: Applied Bioinforma:cs RNA Ribonucleic Acid Week 14, Lecture 28 István Albert Biochemistry and Molecular Biology and Bioinforma:cs Consul:ng Center Penn State Two major domains applica:on

More information

Canadian Bioinforma3cs Workshops

Canadian Bioinforma3cs Workshops Canadian Bioinforma3cs Workshops www.bioinforma3cs.ca Module #: Title of Module 2 1 Module 3 Expression and Differen3al Expression (lecture) Obi Griffith & Malachi Griffith www.obigriffith.org ogriffit@genome.wustl.edu

More information

Quan9fying with sequencing. Week 14, Lecture 27. RNA-Seq concepts. RNA-Seq goals 12/1/ Unknown transcriptome. 2. Known transcriptome

Quan9fying with sequencing. Week 14, Lecture 27. RNA-Seq concepts. RNA-Seq goals 12/1/ Unknown transcriptome. 2. Known transcriptome 2015 - BMMB 852D: Applied Bioinforma9cs Quan9fying with sequencing Week 14, Lecture 27 István Albert Biochemistry and Molecular Biology and Bioinforma9cs Consul9ng Center Penn State Samples consists of

More information

Sequence Analysis 2RNA-Seq

Sequence Analysis 2RNA-Seq Sequence Analysis 2RNA-Seq Lecture 10 2/21/2018 Instructor : Kritika Karri kkarri@bu.edu Transcriptome Entire set of RNA transcripts in a given cell for a specific developmental stage or physiological

More information

Analysis of data from high-throughput molecular biology experiments Lecture 6 (F6, RNA-seq ),

Analysis of data from high-throughput molecular biology experiments Lecture 6 (F6, RNA-seq ), Analysis of data from high-throughput molecular biology experiments Lecture 6 (F6, RNA-seq ), 2012-01-26 What is a gene What is a transcriptome History of gene expression assessment RNA-seq RNA-seq analysis

More information

Applications of short-read

Applications of short-read Applications of short-read sequencing: RNA-Seq and ChIP-Seq BaRC Hot Topics March 2013 George Bell, Ph.D. http://jura.wi.mit.edu/bio/education/hot_topics/ Sequencing applications RNA-Seq includes experiments

More information

Sequencing applications. Today's outline. Hands-on exercises. Applications of short-read sequencing: RNA-Seq and ChIP-Seq

Sequencing applications. Today's outline. Hands-on exercises. Applications of short-read sequencing: RNA-Seq and ChIP-Seq Sequencing applications Applications of short-read sequencing: RNA-Seq and ChIP-Seq BaRC Hot Topics March 2013 George Bell, Ph.D. http://jura.wi.mit.edu/bio/education/hot_topics/ RNA-Seq includes experiments

More information

Decoding Chromatin States with Epigenome Data Advanced Topics in Computa8onal Genomics

Decoding Chromatin States with Epigenome Data Advanced Topics in Computa8onal Genomics Decoding Chromatin States with Epigenome Data 02-715 Advanced Topics in Computa8onal Genomics HMMs for Decoding Chromatin States Epigene8c modifica8ons of the genome have been associated with Establishing

More information

RNAseq / ChipSeq / Methylseq and personalized genomics

RNAseq / ChipSeq / Methylseq and personalized genomics RNAseq / ChipSeq / Methylseq and personalized genomics 7711 Lecture Subhajyo) De, PhD Division of Biomedical Informa)cs and Personalized Biomedicine, Department of Medicine University of Colorado School

More information

Analysis of RNA-seq Data. Bernard Pereira

Analysis of RNA-seq Data. Bernard Pereira Analysis of RNA-seq Data Bernard Pereira The many faces of RNA-seq Applications Discovery Find new transcripts Find transcript boundaries Find splice junctions Comparison Given samples from different experimental

More information

RNA

RNA RNA sequencing Michael Inouye Baker Heart and Diabetes Institute Univ of Melbourne / Monash Univ Summer Institute in Statistical Genetics 2017 Integrative Genomics Module Seattle @minouye271 www.inouyelab.org

More information

ChIP-seq and RNA-seq. Farhat Habib

ChIP-seq and RNA-seq. Farhat Habib ChIP-seq and RNA-seq Farhat Habib fhabib@iiserpune.ac.in Biological Goals Learn how genomes encode the diverse patterns of gene expression that define each cell type and state. Protein-DNA interactions

More information

RNA-sequencing. Next Generation sequencing analysis Anne-Mette Bjerregaard. Center for biological sequence analysis (CBS)

RNA-sequencing. Next Generation sequencing analysis Anne-Mette Bjerregaard. Center for biological sequence analysis (CBS) RNA-sequencing Next Generation sequencing analysis 2016 Anne-Mette Bjerregaard Center for biological sequence analysis (CBS) Terms and definitions TRANSCRIPTOME The full set of RNA transcripts and their

More information

Introduc)on to RNA- seq data analyses

Introduc)on to RNA- seq data analyses Introduc)on to RNA- seq data analyses 7 th BBBC, February 2014 Outline Introduc8on. Biological mo8va8ons experimental procedures. Informa8on provided by RNA- seq data. Analyses of RNA- seq data: methods

More information

Statistical Genomics and Bioinformatics Workshop. Genetic Association and RNA-Seq Studies

Statistical Genomics and Bioinformatics Workshop. Genetic Association and RNA-Seq Studies Statistical Genomics and Bioinformatics Workshop: Genetic Association and RNA-Seq Studies RNA Seq and Differential Expression Analysis Brooke L. Fridley, PhD University of Kansas Medical Center 1 Next-generation

More information

ChIP-seq and RNA-seq

ChIP-seq and RNA-seq ChIP-seq and RNA-seq Biological Goals Learn how genomes encode the diverse patterns of gene expression that define each cell type and state. Protein-DNA interactions (ChIPchromatin immunoprecipitation)

More information

Eucalyptus gene assembly

Eucalyptus gene assembly Eucalyptus gene assembly ACGT Plant Biotechnology meeting Charles Hefer Bioinformatics and Computational Biology Unit University of Pretoria October 2011 About Eucalyptus Most valuable and widely planted

More information

Next Genera*on Sequencing So2ware for Data Management, Analysis, and Visualiza*on. Session W14

Next Genera*on Sequencing So2ware for Data Management, Analysis, and Visualiza*on. Session W14 Next Genera*on Sequencing So2ware for Data Management, Analysis, and Visualiza*on Session W14 1 Tools for Next Genera*on Sequencing Data Analysis Kip Lord Bodi Genomics Core Director Tu2s University Core

More information

measuring gene expression December 5, 2017

measuring gene expression December 5, 2017 measuring gene expression December 5, 2017 transcription a usually short-lived RNA copy of the DNA is created through transcription RNA is exported to the cytoplasm to encode proteins some types of RNA

More information

Pathway Analysis in other data types

Pathway Analysis in other data types Pathway Analysis in other data types Alison Motsinger-Reif, PhD Associate Professor Bioinforma

More information

Introduction to RNA-Seq. David Wood Winter School in Mathematics and Computational Biology July 1, 2013

Introduction to RNA-Seq. David Wood Winter School in Mathematics and Computational Biology July 1, 2013 Introduction to RNA-Seq David Wood Winter School in Mathematics and Computational Biology July 1, 2013 Abundance RNA is... Diverse Dynamic Central DNA rrna Epigenetics trna RNA mrna Time Protein Abundance

More information

Downstream analysis of transcriptomic data

Downstream analysis of transcriptomic data Downstream analysis of transcriptomic data Shamith Samarajiwa CRUK Bioinforma3cs Summer School July 2015 General Methods Dimensionality reduc3on methods (clustering, PCA, MDS) Visualizing PaKerns (heatmaps,

More information

Experimental Design. Sequencing. Data Quality Control. Read mapping. Differential Expression analysis

Experimental Design. Sequencing. Data Quality Control. Read mapping. Differential Expression analysis -Seq Analysis Quality Control checks Reproducibility Reliability -seq vs Microarray Higher sensitivity and dynamic range Lower technical variation Available for all species Novel transcript identification

More information

Transcriptome analysis

Transcriptome analysis Statistical Bioinformatics: Transcriptome analysis Stefan Seemann seemann@rth.dk University of Copenhagen April 11th 2018 Outline: a) How to assess the quality of sequencing reads? b) How to normalize

More information

RNA-Seq Analysis. Simon Andrews, Laura v

RNA-Seq Analysis. Simon Andrews, Laura v RNA-Seq Analysis Simon Andrews, Laura Biggins simon.andrews@babraham.ac.uk @simon_andrews v2018-10 RNA-Seq Libraries rrna depleted mrna Fragment u u u u NNNN Random prime + RT 2 nd strand synthesis (+

More information

Next Genera*on Sequencing II: Personal Genomics. Jim Noonan Department of Gene*cs

Next Genera*on Sequencing II: Personal Genomics. Jim Noonan Department of Gene*cs Next Genera*on Sequencing II: Personal Genomics Jim Noonan Department of Gene*cs Personal genome sequencing Iden*fying the gene*c basis of phenotypic diversity among humans Gene*c risk factors for disease

More information

measuring gene expression December 11, 2018

measuring gene expression December 11, 2018 measuring gene expression December 11, 2018 Intervening Sequences (introns): how does the cell get rid of them? Splicing!!! Highly conserved ribonucleoprotein complex recognizes intron/exon junctions and

More information

Deep sequencing of transcriptomes

Deep sequencing of transcriptomes 1 / 40 Deep sequencing of transcriptomes An introduction to RNA-seq Michael Dondrup UNI BCCS 2. november 2010 2 / 40 Transcriptomics by Ultra-Fast Sequencing Microarrays have been the primary transcriptomics

More information

CBC Data Therapy. Metatranscriptomics Discussion

CBC Data Therapy. Metatranscriptomics Discussion CBC Data Therapy Metatranscriptomics Discussion Metatranscriptomics Extract RNA, subtract rrna Sequence cdna QC Gene expression, function Institute for Systems Genomics: Computational Biology Core bioinformatics.uconn.edu

More information

Introduc)on to Chroma)n IP sequencing (ChIP- seq) data analysis

Introduc)on to Chroma)n IP sequencing (ChIP- seq) data analysis Introduc)on to Chroma)n IP sequencing (ChIP- seq) data analysis Introduc)on to Bioinforma)cs Using NGS Data 27 January 2016 Agata Smialowska BILS, SciLife Lab, Stockholm University Chroma)n state and gene

More information

Pathway Analysis Adding Func2onal Context to High- Throughput Results

Pathway Analysis Adding Func2onal Context to High- Throughput Results Pathway Analysis Adding Func2onal Context to High- Throughput Results Stephen D. Turner, Ph.D. Bioinforma2cs Core Director bioinforma2cs@virginia.edu Outline Bioinforma2cs & the Bioinforma2cs Core Service

More information

1. Introduction Gene regulation Genomics and genome analyses

1. Introduction Gene regulation Genomics and genome analyses 1. Introduction Gene regulation Genomics and genome analyses 2. Gene regulation tools and methods Regulatory sequences and motif discovery TF binding sites Databases 3. Technologies Microarrays Deep sequencing

More information

Lecture: Genetic Basis of Complex Phenotypes Advanced Topics in Computa8onal Genomics

Lecture: Genetic Basis of Complex Phenotypes Advanced Topics in Computa8onal Genomics Lecture: Genetic Basis of Complex Phenotypes 02-715 Advanced Topics in Computa8onal Genomics Genome Polymorphisms A Human Genealogy TCGAGGTATTAAC The ancestral chromosome From SNPS TCGAGGTATTAAC TCTAGGTATTAAC

More information

Comparative analysis of RNA-Seq data with DESeq and DEXSeq

Comparative analysis of RNA-Seq data with DESeq and DEXSeq Comparative analysis of RNA-Seq data with DESeq and DEXSeq Simon Anders EMBL Heidelberg Discovery Two applications of RNA-Seq find new transcripts find transcript boundaries find splice junctions Comparison

More information

Introduction of RNA-Seq Analysis

Introduction of RNA-Seq Analysis Introduction of RNA-Seq Analysis Jiang Li, MS Bioinformatics System Engineer I Center for Quantitative Sciences(CQS) Vanderbilt University September 21, 2012 Goal of this talk 1. Act as a practical resource

More information

Lecture 1 Introduc-on and Data

Lecture 1 Introduc-on and Data STATS M254 / BIOINFO M271 / BIOMATH M271 Sta$s$cal Methods in Computa$onal Biology Spring 2015 Lecture 1 Introduc-on and Data Instructor: Jingyi Jessica Li 1 Outline Introduc-on to molecular biology DNA,

More information

Introduc)on to Chroma)n IP sequencing (ChIP- seq) data analysis

Introduc)on to Chroma)n IP sequencing (ChIP- seq) data analysis Introduc)on to Chroma)n IP sequencing (ChIP- seq) data analysis Introduc)on to Bioinforma)cs using NGS data Linköping, 21 April 2016 Agata Smialowska BILS / NBIS, SciLifeLab, Stockholm University Chroma)n

More information

Integrative Genomics 1a. Introduction

Integrative Genomics 1a. Introduction 2016 Course Outline Integrative Genomics 1a. Introduction ggibson.gt@gmail.com http://www.cig.gatech.edu 1a. Experimental Design and Hypothesis Testing (GG) 1b. Normalization (GG) 2a. RNASeq (MI) 2b. Clustering

More information

Total RNA isola-on End Repair of double- stranded cdna

Total RNA isola-on End Repair of double- stranded cdna Total RNA isola-on End Repair of double- stranded cdna mrna Isola8on using Oligo(dT) Magne8c Beads AAAAAAA A Adenyla8on (A- Tailing) A AAAAAAAAAAAA TTTTTTTTT AAAAAAA TTTTTTTTT TTTTTTTT TTTTTTTTT AAAAAAAA

More information

RNA-Seq with the Tuxedo Suite

RNA-Seq with the Tuxedo Suite RNA-Seq with the Tuxedo Suite Monica Britton, Ph.D. Sr. Bioinformatics Analyst September 2015 Workshop The Basic Tuxedo Suite References Trapnell C, et al. 2009 TopHat: discovering splice junctions with

More information

Quantifying gene expression

Quantifying gene expression Quantifying gene expression Genome GTF (annotation)? Sequence reads FASTQ FASTQ (+reference transcriptome index) Quality control FASTQ Alignment to Genome: HISAT2, STAR (+reference genome index) (known

More information

Comparative analysis of RNA-Seq data with DESeq2

Comparative analysis of RNA-Seq data with DESeq2 Comparative analysis of RNA-Seq data with DESeq2 Simon Anders EMBL Heidelberg Two applications of RNA-Seq Discovery find new transcripts find transcript boundaries find splice junctions Comparison Given

More information

Analysis of RNA-seq Data. Feb 8, 2017 Peikai CHEN (PHD)

Analysis of RNA-seq Data. Feb 8, 2017 Peikai CHEN (PHD) Analysis of RNA-seq Data Feb 8, 2017 Peikai CHEN (PHD) Outline What is RNA-seq? What can RNA-seq do? How is RNA-seq measured? How to process RNA-seq data: the basics How to visualize and diagnose your

More information

Shuji Shigenobu. April 3, 2013 Illumina Webinar Series

Shuji Shigenobu. April 3, 2013 Illumina Webinar Series Shuji Shigenobu April 3, 2013 Illumina Webinar Series RNA-seq RNA-seq is a revolutionary tool for transcriptomics using deepsequencing technologies. genome HiSeq2000@NIBB (Wang 2009 with modifications)

More information

Whole Transcriptome Analysis of Illumina RNA- Seq Data. Ryan Peters Field Application Specialist

Whole Transcriptome Analysis of Illumina RNA- Seq Data. Ryan Peters Field Application Specialist Whole Transcriptome Analysis of Illumina RNA- Seq Data Ryan Peters Field Application Specialist Partek GS in your NGS Pipeline Your Start-to-Finish Solution for Analysis of Next Generation Sequencing Data

More information

less sensitive than RNA-seq but more robust analysis pipelines expensive but quantitiatve standard but typically not high throughput

less sensitive than RNA-seq but more robust analysis pipelines expensive but quantitiatve standard but typically not high throughput Chapter 11: Gene Expression The availability of an annotated genome sequence enables massively parallel analysis of gene expression. The expression of all genes in an organism can be measured in one experiment.

More information

ChIP-seq analysis 2/28/2018

ChIP-seq analysis 2/28/2018 ChIP-seq analysis 2/28/2018 Acknowledgements Much of the content of this lecture is from: Furey (2012) ChIP-seq and beyond Park (2009) ChIP-seq advantages + challenges Landt et al. (2012) ChIP-seq guidelines

More information

GeneScissors: a comprehensive approach to detecting and correcting spurious transcriptome inference owing to RNA-seq reads misalignment

GeneScissors: a comprehensive approach to detecting and correcting spurious transcriptome inference owing to RNA-seq reads misalignment GeneScissors: a comprehensive approach to detecting and correcting spurious transcriptome inference owing to RNA-seq reads misalignment Zhaojun Zhang, Shunping Huang, Jack Wang, Xiang Zhang, Fernando Pardo

More information

Experimental design of RNA-Seq Data

Experimental design of RNA-Seq Data Experimental design of RNA-Seq Data RNA-seq course: The Power of RNA-seq Thursday June 6 th 2013, Marco Bink Biometris Overview Acknowledgements Introduction Experimental designs Randomization, Replication,

More information

David M. Rocke Division of Biostatistics and Department of Biomedical Engineering University of California, Davis

David M. Rocke Division of Biostatistics and Department of Biomedical Engineering University of California, Davis David M. Rocke Division of Biostatistics and Department of Biomedical Engineering University of California, Davis Outline RNA-Seq for differential expression analysis Statistical methods for RNA-Seq: Structure

More information

Package goseq. R topics documented: December 23, 2017

Package goseq. R topics documented: December 23, 2017 Package goseq December 23, 2017 Version 1.30.0 Date 2017/09/04 Title Gene Ontology analyser for RNA-seq and other length biased data Author Matthew Young Maintainer Nadia Davidson ,

More information

Transcriptome Assembly, Functional Annotation (and a few other related thoughts)

Transcriptome Assembly, Functional Annotation (and a few other related thoughts) Transcriptome Assembly, Functional Annotation (and a few other related thoughts) Monica Britton, Ph.D. Sr. Bioinformatics Analyst June 23, 2017 Differential Gene Expression Generalized Workflow File Types

More information

Bioinformatics and Statistical challenges from the analysis of NGS-Metagenomics experiments

Bioinformatics and Statistical challenges from the analysis of NGS-Metagenomics experiments Bioinformatics and Statistical challenges from the analysis of NGS-Metagenomics experiments Jean-Jacques Daudin & Sophie Schbath ANR Project Computational Biology for Metagenomics Experiments () Plant

More information

SO YOU WANT TO DO A: RNA-SEQ EXPERIMENT MATT SETTLES, PHD UNIVERSITY OF CALIFORNIA, DAVIS

SO YOU WANT TO DO A: RNA-SEQ EXPERIMENT MATT SETTLES, PHD UNIVERSITY OF CALIFORNIA, DAVIS SO YOU WANT TO DO A: RNA-SEQ EXPERIMENT MATT SETTLES, PHD UNIVERSITY OF CALIFORNIA, DAVIS SETTLES@UCDAVIS.EDU Bioinformatics Core Genome Center UC Davis BIOINFORMATICS.UCDAVIS.EDU DISCLAIMER This talk/workshop

More information

RNA-Sequencing analysis

RNA-Sequencing analysis RNA-Sequencing analysis Markus Kreuz 25. 04. 2012 Institut für Medizinische Informatik, Statistik und Epidemiologie Content: Biological background Overview transcriptomics RNA-Seq RNA-Seq technology Challenges

More information

DNASeq: Analysis pipeline and file formats Sumir Panji, Gerrit Boha and Amel Ghouila

DNASeq: Analysis pipeline and file formats Sumir Panji, Gerrit Boha and Amel Ghouila DNASeq: Analysis pipeline and file formats Sumir Panji, Gerrit Boha and Amel Ghouila Bioinforma>cs analysis and annota>on of variants in NGS data workshop Cape Town, 4th to 6th April 2016 DNA Sequencing:

More information

Introduction to RNA sequencing

Introduction to RNA sequencing Introduction to RNA sequencing Bioinformatics perspective Olga Dethlefsen NBIS, National Bioinformatics Infrastructure Sweden November 2017 Olga (NBIS) RNA-seq November 2017 1 / 49 Outline Why sequence

More information

Introduc)on to Databases and Resources Biological Databases and Resources

Introduc)on to Databases and Resources Biological Databases and Resources Introduc)on to Bioinforma)cs Online Course : IBT Introduc)on to Databases and Resources Biological Databases and Resources Learning Objec)ves Introduc)on to Databases and Resources - Understand how bioinforma)cs

More information

RNA-Seq Now What? BIS180L Professor Maloof May 24, 2018

RNA-Seq Now What? BIS180L Professor Maloof May 24, 2018 RNA-Seq Now What? BIS180L Professor Maloof May 24, 2018 We have differentially expressed genes, what do we want to know about them? We have differentially expressed genes, what do we want to know about

More information

Introduction to RNAseq Analysis. Milena Kraus Apr 18, 2016

Introduction to RNAseq Analysis. Milena Kraus Apr 18, 2016 Introduction to RNAseq Analysis Milena Kraus Apr 18, 2016 Agenda What is RNA sequencing used for? 1. Biological background 2. From wet lab sample to transcriptome a. Experimental procedure b. Raw data

More information

Transcriptomics analysis with RNA seq: an overview Frederik Coppens

Transcriptomics analysis with RNA seq: an overview Frederik Coppens Transcriptomics analysis with RNA seq: an overview Frederik Coppens Platforms Applications Analysis Quantification RNA content Platforms Platforms Short (few hundred bases) Long reads (multiple kilobases)

More information

Differential gene expression analysis using RNA-seq

Differential gene expression analysis using RNA-seq https://abc.med.cornell.edu/ Differential gene expression analysis using RNA-seq Applied Bioinformatics Core, August 2017 Friederike Dündar with Luce Skrabanek & Ceyda Durmaz Day 3 QC of aligned reads

More information

RNA-Seq de novo assembly training

RNA-Seq de novo assembly training RNA-Seq de novo assembly training Training session aims Give you some keys elements to look at during read quality check. Transcriptome assembly is not completely a strait forward process : Multiple strategies

More information

Basics of RNA-Seq. (With a Focus on Application to Single Cell RNA-Seq) Michael Kelly, PhD Team Lead, NCI Single Cell Analysis Facility

Basics of RNA-Seq. (With a Focus on Application to Single Cell RNA-Seq) Michael Kelly, PhD Team Lead, NCI Single Cell Analysis Facility 2018 ABRF Meeting Satellite Workshop 4 Bridging the Gap: Isolation to Translation (Single Cell RNA-Seq) Sunday, April 22 Basics of RNA-Seq (With a Focus on Application to Single Cell RNA-Seq) Michael Kelly,

More information

Canadian Bioinforma2cs Workshops

Canadian Bioinforma2cs Workshops Canadian Bioinforma2cs Workshops www.bioinforma2cs.ca Module #: Title of Module 2 1 Introduction to Microarrays & R Paul Boutros Morning Overview 09:00-11:00 Microarray Background Microarray Pre- Processing

More information

RNA-Seq analysis using R: Differential expression and transcriptome assembly

RNA-Seq analysis using R: Differential expression and transcriptome assembly RNA-Seq analysis using R: Differential expression and transcriptome assembly Beibei Chen Ph.D BICF 12/7/2016 Agenda Brief about RNA-seq and experiment design Gene oriented analysis Gene quantification

More information

Computational & Quantitative Biology Lecture 6 RNA Sequencing

Computational & Quantitative Biology Lecture 6 RNA Sequencing Peter A. Sims Dept. of Systems Biology Dept. of Biochemistry & Molecular Biophysics Sulzberger Columbia Genome Center October 27, 2014 Computational & Quantitative Biology Lecture 6 RNA Sequencing We Have

More information

Introduction to RNA-Seq

Introduction to RNA-Seq Introduction to RNA-Seq Monica Britton, Ph.D. Sr. Bioinformatics Analyst March 2015 Workshop Overview of RNA-Seq Activities RNA-Seq Concepts, Terminology, and Work Flows Using Single-End Reads and a Reference

More information

NEXT GENERATION SEQUENCING. Farhat Habib

NEXT GENERATION SEQUENCING. Farhat Habib NEXT GENERATION SEQUENCING HISTORY HISTORY Sanger Dominant for last ~30 years 1000bp longest read Based on primers so not good for repetitive or SNPs sites HISTORY Sanger Dominant for last ~30 years 1000bp

More information

User Guide. MAGNET : MicroArray & RNAseq Gene expression Network Evalua=on Toolkit. Page 1

User Guide. MAGNET : MicroArray & RNAseq Gene expression Network Evalua=on Toolkit. Page 1 User Guide MAGNET : MicroArray & RNAseq Gene expression Network Evalua=on Toolkit Page 1 Case Western Reserve University February 2012 Page 2 Page 3 1 - Introduction This sec=on will introduce MAGNET:

More information

A survey of statistical software for analysing RNA-seq data

A survey of statistical software for analysing RNA-seq data A survey of statistical software for analysing RNA-seq data Dexiang Gao, 1,5* Jihye Kim, 2 Hyunmin Kim, 4 Tzu L. Phang, 3 Heather Selby, 2 Aik Choon Tan 2,5 and Tiejun Tong 6** 1 Department of Pediatrics,

More information

Finding Genes with Genomics Technologies

Finding Genes with Genomics Technologies PLNT2530 Plant Biotechnology (2018) Unit 7 Finding Genes with Genomics Technologies Unless otherwise cited or referenced, all content of this presenataion is licensed under the Creative Commons License

More information

Genomic resources. for non-model systems

Genomic resources. for non-model systems Genomic resources for non-model systems 1 Genomic resources Whole genome sequencing reference genome sequence comparisons across species identify signatures of natural selection population-level resequencing

More information

Experimental Design. Dr. Matthew L. Settles. Genome Center University of California, Davis

Experimental Design. Dr. Matthew L. Settles. Genome Center University of California, Davis Experimental Design Dr. Matthew L. Settles Genome Center University of California, Davis settles@ucdavis.edu What is Differential Expression Differential expression analysis means taking normalized sequencing

More information

Gene Regulatory Networks Computa.onal Genomics Seyoung Kim

Gene Regulatory Networks Computa.onal Genomics Seyoung Kim Gene Regulatory Networks 02-710 Computa.onal Genomics Seyoung Kim Transcrip6on Factor Binding Transcrip6on Control Gene transcrip.on is influenced by Transcrip.on factor binding affinity for the regulatory

More information

RNAseq Applications in Genome Studies. Alexander Kanapin, PhD Wellcome Trust Centre for Human Genetics, University of Oxford

RNAseq Applications in Genome Studies. Alexander Kanapin, PhD Wellcome Trust Centre for Human Genetics, University of Oxford RNAseq Applications in Genome Studies Alexander Kanapin, PhD Wellcome Trust Centre for Human Genetics, University of Oxford RNAseq Protocols Next generation sequencing protocol cdna, not RNA sequencing

More information

Introduction to Next Generation Sequencing

Introduction to Next Generation Sequencing The Sequencing Revolution Introduction to Next Generation Sequencing Dena Leshkowitz,WIS 1 st BIOmics Workshop High throughput Short Read Sequencing Technologies Highly parallel reactions (millions to

More information

The Genome Analysis Centre. Building Excellence in Genomics and Computa5onal Bioscience

The Genome Analysis Centre. Building Excellence in Genomics and Computa5onal Bioscience Building Excellence in Genomics and Computa5onal Bioscience Resequencing approaches Sarah Ayling Crop Genomics and Diversity sarah.ayling@tgac.ac.uk Why re- sequence plants? To iden

More information

RNAseq and Variant discovery

RNAseq and Variant discovery RNAseq and Variant discovery RNAseq Gene discovery Gene valida5on training gene predic5on programs Gene expression studies Paris japonica Gene discovery Understanding physiological processes Dissec5ng

More information

Next- genera*on Sequencing. Lecture 13

Next- genera*on Sequencing. Lecture 13 Next- genera*on Sequencing Lecture 13 ChIP- seq Applica*ons iden%fy sequence varia%ons DNA- seq Iden%fy Pathogens RNA- seq Kahvejian et al, 2008 Protein-DNA interaction DNA is the informa*on carrier of

More information

Differential expression analysis for sequencing count data. Simon Anders

Differential expression analysis for sequencing count data. Simon Anders Differential expression analysis for sequencing count data Simon Anders Two applications of RNA-Seq Discovery find new transcripts find transcript boundaries find splice junctions Comparison Given samples

More information

Human housekeeping genes are compact

Human housekeeping genes are compact Human housekeeping genes are compact Eli Eisenberg and Erez Y. Levanon Compugen Ltd., 72 Pinchas Rosen Street, Tel Aviv 69512, Israel Abstract arxiv:q-bio/0309020v1 [q-bio.gn] 30 Sep 2003 We identify a

More information

Introduction to RNA-Seq

Introduction to RNA-Seq Introduction to RNA-Seq Monica Britton, Ph.D. Bioinformatics Analyst September 2014 Workshop Overview of Today s Activities Morning RNA-Seq Concepts, Terminology, and Work Flows Two-Condition Differential

More information

Bi 8 Lecture 3. DNA to RNA: Transcription and Splicing. Katalin Fejes Toth 12 January 2016

Bi 8 Lecture 3. DNA to RNA: Transcription and Splicing. Katalin Fejes Toth 12 January 2016 Bi 8 Lecture 3 DNA to RNA: Transcription and Splicing Katalin Fejes Toth 12 January 2016 Alberts 6 th edi5on: Ch. 6: pp. 301-333 Readings for this lecture (Alberts 5 th edi5on equivalents: Ch. 6: pp. 329-366)

More information

RNA-seq differential expression analysis. bioconnector.org/workshops

RNA-seq differential expression analysis. bioconnector.org/workshops RNA-seq differential expression analysis bioconnector.org/workshops Agenda Our data: source, pre-processing, structure Importing & exploring data Processing and analysis with DESeq2 - Structuring the count

More information

Mapping strategies for sequence reads

Mapping strategies for sequence reads Mapping strategies for sequence reads Ernest Turro University of Cambridge 21 Oct 2013 Quantification A basic aim in genomics is working out the contents of a biological sample. 1. What distinct elements

More information

Single cell RNA sequencing. Åsa Björklund

Single cell RNA sequencing. Åsa Björklund Single cell RNA sequencing Åsa Björklund asa.bjorklund@scilifelab.se Outline Why single cell gene expression? Library prepara>on methods SeBng up experiments Computa>onal analysis Defining cell types Iden>fying

More information

Background Wikipedia Lee and Mahadavan, JCB, 2009 History (Platform Comparison) P Park, Nature Review Genetics, 2009 P Park, Nature Reviews Genetics, 2009 Rozowsky et al., Nature Biotechnology, 2009

More information

Post- sequencing quality evalua2on. or what to do when you get your reads from the sequencer

Post- sequencing quality evalua2on. or what to do when you get your reads from the sequencer Post- sequencing quality evalua2on or what to do when you get your reads from the sequencer The fastq file contains informa2on about sequence and quality Read Iden(fier Sequence Quality Sources of Library

More information

Exercises: Analysing ChIP-Seq data

Exercises: Analysing ChIP-Seq data Exercises: Analysing ChIP-Seq data Version 2018-03-2 Exercises: Analysing ChIP-Seq data 2 Licence This manual is 2018, Simon Andrews. This manual is distributed under the creative commons Attribution-Non-Commercial-Share

More information

Introduction to transcriptome analysis using High Throughput Sequencing technologies. D. Puthier 2012

Introduction to transcriptome analysis using High Throughput Sequencing technologies. D. Puthier 2012 Introduction to transcriptome analysis using High Throughput Sequencing technologies D. Puthier 2012 A typical RNA-Seq experiment Library construction Protocol variations Fragmentation methods RNA: nebulization,

More information

A normalization method based on variance and median adjustment for massive mrna polyadenylation data

A normalization method based on variance and median adjustment for massive mrna polyadenylation data ISSN : 0974-7435 Volume 8 Issue 4 A normalization method based on variance and median adjustment for massive mrna polyadenylation data Guoli Ji, Ying Wang, Mingchen Wu, Yangzi Zhang, Xiaohui Wu* Department

More information

Genome 373: Gene Predic/on I. Doug Fowler

Genome 373: Gene Predic/on I. Doug Fowler Genome 373: Gene Predic/on I Doug Fowler Outline Review of gene structure Scale of the problem Solu;ons Empirical methods Ab ini&o predic;on What is a gene? A locatable region of genomic sequence, corresponding

More information

Analysis of RNA-seq Data

Analysis of RNA-seq Data Analysis of RNA-seq Data A physicist and an engineer are in a hot-air balloon. Soon, they find themselves lost in a canyon somewhere. They yell out for help: "Helllloooooo! Where are we?" 15 minutes later,

More information

Functional Genomics Overview RORY STARK PRINCIPAL BIOINFORMATICS ANALYST CRUK CAMBRIDGE INSTITUTE 18 SEPTEMBER 2017

Functional Genomics Overview RORY STARK PRINCIPAL BIOINFORMATICS ANALYST CRUK CAMBRIDGE INSTITUTE 18 SEPTEMBER 2017 Functional Genomics Overview RORY STARK PRINCIPAL BIOINFORMATICS ANALYST CRUK CAMBRIDGE INSTITUTE 18 SEPTEMBER 2017 Agenda What is Functional Genomics? RNA Transcription/Gene Expression Measuring Gene

More information

RNA-Seq. Joshua Ainsley, PhD Postdoctoral Researcher Lab of Leon Reijmers Neuroscience Department Tufts University

RNA-Seq. Joshua Ainsley, PhD Postdoctoral Researcher Lab of Leon Reijmers Neuroscience Department Tufts University RNA-Seq Joshua Ainsley, PhD Postdoctoral Researcher Lab of Leon Reijmers Neuroscience Department Tufts University joshua.ainsley@tufts.edu Day five Alternative splicing Assembly RNA edits Alternative splicing

More information