RNA-seq Analysis in Galaxy

Slides:



Advertisements
Similar presentations
IMGS 2012 Bioinformatics Workshop: RNA Seq using Galaxy
Advertisements

Peter Tsai Bioinformatics Institute, University of Auckland
DEG Mi-kyoung Seo.
RNAseq analysis Bioinformatics Analysis Team
Xiaole Shirley Liu STAT115, STAT215, BIO298, BIST520
Transcriptomics Jim Noonan GENE 760.
mRNA-Seq: methods and applications
Bacterial Genome Assembly | Victor Jongeneel Radhika S. Khetani
Before we start: Align sequence reads to the reference genome
NGS Analysis Using Galaxy
An Introduction to RNA-Seq Transcriptome Profiling with iPlant
BACKGROUND Have a gene involved in neurological disease, its function unclear Knockout is lethal, so… Designed a conditional knockout (cKO) mouse where.
Introduction to RNA-Seq and Transcriptome Analysis
Expression Analysis of RNA-seq Data
Genomics Virtual Lab: analyze your data with a mouse click Igor Makunin School of Agriculture and Food Sciences, UQ, April 8, 2015.
Transcriptome analysis With a reference – Challenging due to size and complexity of datasets – Many tools available, driven by biomedical research – GATK.
RNAseq analyses -- methods
Introduction to RNA-Seq & Transcriptome Analysis
Next Generation DNA Sequencing
Schedule change Day 2: AM - Introduction to RNA-Seq (and a touch of miRNA-Seq) Day 2: PM - RNA-Seq practical (Tophat + Cuffdiff pipeline on Galaxy) Day.
Transcriptome Analysis
Next Generation Sequencing. Overview of RNA-seq experimental procedures. Wang L et al. Briefings in Functional Genomics 2010;9: © The Author.
RNA-Seq in Galaxy Igor Makunin QAAFI, Internal Workshop, April 17, 2015.
An Introduction to RNA-Seq Transcriptome Profiling with iPlant.
Introductory RNA-seq Transcriptome Profiling. Before we start: Align sequence reads to the reference genome The most time-consuming part of the analysis.
Introduction to RNA-Seq
The iPlant Collaborative Community Cyberinfrastructure for Life Science Tools and Services Workshop RNA-Seq using the Discovery Environment And COGE.
RNA-seq workshop COUNTING & HTSEQ Erin Osborne Nishimura.
IPlant Collaborative Discovery Environment RNA-seq Basic Analysis Log in with your iPlant ID; three orange icons.
Introductory RNA-seq Transcriptome Profiling. Before we start: Align sequence reads to the reference genome The most time-consuming part of the analysis.
Transcriptomics Sequencing. over view The transcriptome is the set of all RNA molecules, including mRNA, rRNA, tRNA, and other non coding RNA produced.
Galaxy – Set up your account. Galaxy – Two ways to get your data.
RNA-Seq Transcriptome Profiling. Before we start: Align sequence reads to the reference genome The most time-consuming part of the analysis is doing the.
Introduction to RNAseq
The iPlant Collaborative Community Cyberinfrastructure for Life Science Tools and Services Workshop RNA-Seq visualization with cummeRbund.
The iPlant Collaborative
An Introduction to RNA-Seq Transcriptome Profiling with iPlant (
The iPlant Collaborative
No reference available
Manuel Holtgrewe Algorithmic Bioinformatics, Department of Mathematics and Computer Science PMSB Project: RNA-Seq Read Simulation.
Canadian Bioinformatics Workshops
User-friendly Galaxy interface and analysis workflows for deep sequencing data Oskari Timonen and Petri Pölönen.
Canadian Bioinformatics Workshops
Canadian Bioinformatics Workshops
Canadian Bioinformatics Workshops
Canadian Bioinformatics Workshops
Canadian Bioinformatics Workshops
Canadian Bioinformatics Workshops
RNA Seq Analysis Aaron Odell June 17 th Mapping Strategy A few questions you’ll want to ask about your data… - What organism is the data from? -
Introductory RNA-seq Transcriptome Profiling of the hy5 mutation in Arabidopsis thaliana.
Canadian Bioinformatics Workshops
Canadian Bioinformatics Workshops
Arrays How do they work ? What are they ?. WT Dwarf Transgenic Other species Arrays are inverted Northerns: Extract target RNA YFG Label probe + hybridise.
RNA-Seq with the Tuxedo Suite Monica Britton, Ph.D. Sr. Bioinformatics Analyst September 2015 Workshop.
Introductory RNA-seq Transcriptome Profiling
GCC Workshop 9 RNA-Seq with Galaxy
RNA Quantitation from RNAseq Data
WS9: RNA-Seq Analysis with Galaxy (non-model organism )
RNA-Seq analysis in R (Bioconductor)
S1 Supporting information Bioinformatic workflow and quality of the metrics Number of slides: 10.
High-Throughput Analysis of Genomic Data [S7] ENRIQUE BLANCO
Canadian Bioinformatics Workshops
Canadian Bioinformatics Workshops
Introductory RNA-Seq Transcriptome Profiling
Kallisto: near-optimal RNA seq quantification tool
Additional file 2: RNA-Seq data analysis pipeline
Sequence Analysis - RNA-Seq 2
Introduction to RNA-Seq & Transcriptome Analysis
Differential Expression of RNA-Seq Data
RNA-Seq Data Analysis UND Genomics Core.
Presentation transcript:

RNA-seq Analysis in Galaxy Pawel Michalak (pawel@vbi.vt.edu)

Two applications of RNA-Seq Discovery find new transcripts find transcript boundaries find splice junctions Comparison Given samples from different experimental conditions, find effects of the treatment on gene expression strengths Isoform abundance ratios, splice patterns, transcript boundaries

Specific Objectives By the end of this module, you should Be more familiar with the DE user interface Understand the starting data for RNA-seq analysis Be able to align short sequence reads with a reference genome in the DE Be able to analyze differential gene expression in the DE Be able to use DE text manipulation tools to explore the gene expression data

Conceptual Overview

Key Definitions

Key Definitions

Key Definitions

Key Definitions

RNA-seq file formats

File formats – FASTQ

File formats – SAM/BAM

File formats – GTF

Experimental Design

Steps in RNA-seq Analysis

http://galaxyproject.org/ Click

http://galaxyproject.org/ Click

Galaxy workflow

Galaxy workflow

Galaxy workflow

QC and Data Prepping in Galaxy

Data Quality Assessment: FastQC

Data Quality Assessment: FastQC

Data Quality Assessment: FastQC

Data Quality Assessment: FastQC

Data Quality Assessment: FastQC

Read Mapping

Why TopHat?

TopHat2 in Galaxy

CuffLinks and CuffDiff CuffLinks is a program that assembles aligned RNA-Seq reads into transcripts, estimates their abundances, and tests for differential expression and regulation transcriptome-wide. CuffDiff is a program within CuffLinks that compares transcript abundance between samples

Cuffcompare and Cuffmerge

CuffDiff results example

RNA-seq results normalization Differential Expression (DE) requires comparison of 2 or more RNA-seq samples. Number of reads (coverage) will not be exactly the same for each sample Problem: Need to scale RNA counts per gene to total sample coverage Solution – divide counts per million reads Problem: Longer genes have more reads, gives better chance to detect DE Solution – divide counts by gene length Result = RPKM (Reads Per KB per Million)

RPKM normalization

RNA-seq hands-on Go to http://galaxyproject.org/ and then type in the URL address field https://usegalaxy.org/u/jeremy/d/257ca40a619a8591 (GM12878 cell line) Click the green + near the top right corner to add the dataset to your history then click on start using the dataset to return to your history, and then repeat with https://usegalaxy.org/u/jeremy/d/7f717288ba4277c6 (h1-hESC cell line)

RNA-seq hands-on http://staff.vbi.vt.edu/pawel/RNASeq.pdf