SlideShare una empresa de Scribd logo
1 de 58
Descargar para leer sin conexión
Galaxy RNA-Seq
Analysis: Tuxedo Protocol
ChangBum Hong, KT Bioinformatics, GenomeCloud SCIC	

genome-cloud.com
This work is licensed under the Creative Commons Attribution-NonCommercialShareAlike 3.0 New Zealand License. To view a copy of this license, visit http://
creativecommons.org/licenses/by-nc-sa/3.0/nz/ or send a letter to Creative
Commons, 171 Second Street, Suite 300, San Francisco, California, 94105, USA.
Introduction
•

RNA-Seq	


•
•

•

Transcriptome assembly	


•

Qualitative identification of expressed sequence	


Differential expression analysis	


•

Quantitative measurement of transcript expression	


RNA-Seq Applications	


•

Annotation: Identify novel genes, transcripts, exons, splicing events,
ncRNAs	


•
•

Detecting RNA editing and SNPs	

Measurements: RNA quantification and differential gene expression
Experimental design
• What are my goals?	

• Transcriptome assembly?	

• Differential expression analysis?	

• Identify rare transcripts?	

• What are the characteristics of my system?	

• Large, complex genome?	

• Introns and high degree of alternative splicing?	

• No reference genome or transcriptome?
Experimental Outputs

Assembly

Expression	

Differentially expressed

Splicing
Sequencing
• Platforms	

• Library preparation	

• Multiplexing	

• Sequence reads	

• File names	

• Fastq format(Formats vary)	

• 4 lines per read

Illumina Read ID
Data Quality Control
• Data Quality Assessment	

• Identify poor/bad sample	

• Identify contaminates	

• Trimming: remove bad bases from read	

• Filtering: remove bad reads from library
Read Mapping
• Alignment algorithm must be	

• fast	

• able to handle SNPs, indels, and sequencing errors	

• allow for introns for reference genome alignment	

• Input	

• fastq read library	

• reference genome index	

• insert size mean and stddev(for paired-end libraries)	

• Output	

• SAM (text) / BAM (binary) alignment files
Differential Expression
• Cuffdiff (Cufflinks package)	

• Pairwise comparisons	

• Differnetial gene, transcript, and primary transcript
expression	


• Easy to use, well documented	

• Input: transcriptome, SAM/BAM read alignments
Transcriptome Assembly
• RNA-Seq	

• Reference genome	

• Reference transcriptome	

• RNA-Seq	

• Reference genome	

• No reference transcriptome	

• RNA-Seq	

• No reference genome	

• No reference transcriptome
Reference
Genome

FASTA

GFF/GTF

Experimental Design

Referecne	

Transcriptome

RNA

Sequencing
FASTQ

Reads
FASTQ

Data Quality Control

Tuxedo protocol
Combining tools in a pipeline
• Linux Command-line Tools	

• Shell script, Makefile	

• GUI Based pipeline	

• DNANexus 	

• SevenBridegs Genomics	

• Galaxy	

• Open Source	

• Wrapper for command line utilites	

• Workflows	

• Save all steps you did in your analysis	

• Return the entire analysis on a new dataset	

• Share your workflow with other people
How to use Galaxy?
GALAXY MAIN: User disk quotas 250GB for registered users, maximum concurrent jobs: 8
NO 	

WAIT 	

TIMES

NO	

NO 	

JOB	

STORAGE 	

SUBMISSION
QUOTAS
LIMITS

NO	

DATA	

TRANSFER	

BOTTLENECKS

NO	

IT	

EXPERIENCE	

REQUIRED

NO	

REQUIRED	

INFRASTRUCTURE

COST

GALAXY
MAIN

Free

LOCAL
GALAXY

Free ?

CLOUD
GALAXY	

(AMAZON)

동일사양 대비
약 2배 (KT의)

SLIPSTREAM
GALAXY

$19,995	

(2천2백만원)

KT
GenomeCloud	

GALAXY

시간당 740원
부터
Outline of tutorial
• Starting Galaxy	

• Mapping with Tophat	

• Workflows	

• Visualizing alignment with IGV	

• Computing differential expression with cuffdiff	

• Cuffdiff visuaalization with CummeRbund
Starting Galaxy
• Tutorial Dataset	

• Accessing Galaxy	

• Import files for one sample into current history	

• Set file attributes	

• Run FastQC
Tutorial Dataset
• FASTQ files (fastq): Sequence Reads	

• Reference (fasta): Genome Sequence (galaxy default)	

• Geneset (GTF / GFF3): Reference Geneset	

• Bowtie2 index: Reference index files for Bowtie2
(galaxy default)
Tutorial Dataset
Reference & Gene sets

• Ensembl 	

• http://www.ensembl.org/info/data/ftp/index.html
Tutorial Dataset
Reference & Gene sets
•illumina iGenomes	


• The iGenomes are a collection of reference sequences and annotation files for commonly analyzed

organisms. The files have been downloaded from Ensembl, NCBI, or UCSC, and chromosome names have
been changed to be simple and consistent with their download source. Each iGenome is available as a
compressed file that contains sequences and annotation files for a single genomic build of an organism.	


• http://support.illumina.com/sequencing/sequencing_software/igenome.ilmn
Tutorial Dataset
Sequencing data

•Sequencing data (Drosophila melanogaster)	

• Gene Expression Omnibus at accession GSE32038	

• http://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE32038
Biological replicates vs.
technical replicates
Technical Replicates

Biological Replicates
Accessing Galaxy
•
•

Open a web browser and navigate to Galaxy website usegalaxy.org or www.genome-cloud.com	

Log in with username and password

select galaxy service

GenomeCloud (genome-cloud.com)
when your galaxy is ready 	

you will recive the e-mail

access the galaxy via public ip address

you can register via user menu > register

Center pane
Tools pane

History pane
Import files
•
•

Open a web browser and navigate to Galaxy website usegalaxy.org or www.genome-cloud.com	

Log in with username and password
example fastq and gtf files are located in shared data > RNA-Seq with Drosophila melanogaster

import data into your history panel (read to analysis)
Set file attributes
•
•

In the history pane click on the pencil icon	

Enter “fastqsanger” (It will takes time)

Sanger Phread+33 fastqsanger (cassava 1.8 ▲ )	

Ilumina 1.3 Phread+64 fastqillunina (cassava 1.8 ▼)	

Solexa Solexa+64 fastqsolexa
Tophat options	

--solexa-quals: Use the Solexa scale for quality values in FASTQ files	

--solexa1.3-quals: Phred64/Illumina 1.3~1.5	


!

BWA options	

-l : The input is in the Illumina 1.3+ read format (quality equals ASCII-64)	


!

GenomeCloud (g-Analysis)
Error probability

Quality Score Encoding

CASAVA 1.8.2 Quality Score (or Q-score)
Run FastQC
•
•

Load the FastQC tool from the tool pane	

Set the input file (repeat this step on the C1, C2 all piar files)
wait

running

done

error

Galaxy status
When fastqc has finished running,	

click on the eye on the FastQC output file 	

to display
illumina	

(in-house data)

IonTorrent	

(in-house data)

illumina	

(good dataset in FastQC homepage)

illumina	

(bad dataset in FastQC homepage)

Per base sequence quality
illumina	

(in-house data)

IonTorrent	

(in-house data)

illumina	

(good dataset in FastQC homepage)

illumina	

(bad dataset in FastQC homepage)

Per sequence quality score

illumina	

(in-house data)

IonTorrent	

(in-house data)

illumina	

(good dataset in FastQC homepage)

Per base sequence content

illumina	

(bad dataset in FastQC homepage)
illumina	

(in-house data)

IonTorrent	

(in-house data)

illumina	

(good dataset in FastQC homepage)

illumina	

(bad dataset in FastQC homepage)

Per base GC content

illumina	

(in-house data)

IonTorrent	

(in-house data)

illumina	

(good dataset in FastQC homepage)

illumina	

(bad dataset in FastQC homepage)

Per sequence GC content

illumina	

(in-house data)

IonTorrent	

(in-house data)

illumina	

(good dataset in FastQC homepage)

Per base N content

illumina	

(bad dataset in FastQC homepage)
illumina	

(in-house data)

IonTorrent	

(in-house data)

illumina	

(good dataset in FastQC homepage)

illumina	

(bad dataset in FastQC homepage)

Sequence Length Distribution

illumina	

(in-house data)

IonTorrent	

(in-house data)

illumina	

(good dataset in FastQC homepage)

Sequence Duplication Levels

illumina	

(bad dataset in FastQC homepage)
Mapping with Tophat
• Initial Tophat run	

• Determine insert size	

• Rerun Tophat with correct insert size	

• Review mapping statistics
Initial Tophat run
•
•
•

Use Full Tophat paramters	

Paired-end FASTQ files, Select reference genome, Use Own Juctions(Yes), Use Gene Annotation Model(Yes)	

Gene Model Anntations (use GFF file)
Determine insert size
•

Load the insert size tool “NGS: Picard (beta) -> Insertion size meterics”
Determine insert size
•
•

Click “eye” icon	

Identify the MIN_INSERT_SIZE (198)
Rerun Tophat
•
•
•

Click any one of the Tophat2 output files in the history panne	

Click on the circular blue arrow icon	

Change the “Mean Inner Distance between Mate Pairs” (198)
Tophat Output
•
•

unmapped.bam (BAM)	


•

junctions.bed (BED): list BED track of junctions reported by Tophat
where each junction consists of two connected BED blocks where
each block is as long as the max overhang of nay read spanning
juction	


•

deletions.bed (BED): mentions the last genomic base before the
deletion	


•

insertions.bed (BED): mentions the first genomic base of deletion

accepted_hits.bam (BAM): a list of read alignments in BAM/SAM
format
Load files into IGV
•
•
•
•

Click on the “accepted hits” file in the history pane	

Click on the “display with IGV web current”	

A file named “igv.jnlp” will be downloaded by your browser	

Open with text editor copy BAM file location
IGV with Housekeeping gene

http://www.sabiosciences.com/rt_pcr_product/HTML/PADM-000Z.html
Load files into IGV
•
•

Enter “Act42A” in the search box to view the reads aligning	

Right-click on the coverage track and select “Set Data Range” (max value to 4372)

Housekeeping gene: Act42A
Set max value
IGV with Differential
Expression
Keyword: regucalcin (calcium-binding protein)

this gene has four isoforms
Load files into Trackster
•
•
•

Click on the “accepted hits” file in the history pane	

Click on the graph icon and select “Trackster”	

Select bam files
drag into new group

move to regucalcin gene

create new group ‘Add group’
set max value
Run cuffdiff
•
•
•

Load the Cuffdiff tool: “NGS:RNA Analysis->Cuffdiff ”	

Perform replicate analysis(Yes)	

Add new Group / Add new Replicate
Cuffdiff output
• Genes: gene differential FPKM	

• Isoforms: Transcript differential FPKM	

• CDS: Coding sequence differential FPKM
•
•

View and filter cuffdiff
output
Differential Gene Expression (DGE)	

Filter out genes with significant change in expression with a log fold-change of at least 1 “C14
== ‘yes’ and abs(c10)>1” in the “With following condition” text box
•
•

Cuffdiff visualization with
CummeRbund
Load the CummeRbund tool: NGS:RNA Analysis->cummerbund	

Plot type: Density, check the “Replicates” box
Samples have similar density
distribution(density plot)

Samples cluster by expression condition	

(MDS / PCA plot)

Samples cluster by experimental condition	

(Dendogram)
Volcano

Differential analysis results for regucalcin	

Expression plot shows clear differences in the
expression of regucalcin across conditions C1
and C2 (four alternative isoforms)

Scatter plots highlight general similarities
and specific outliers between conditions
C1 and C2
Extract workflow from
current history
•

Click on the small gear icon and select “Extract Workflow”
Edit workflow
•
•

Click on “Workflow” at the top of the Galaxy window	

Move the elements of the workflow
Run workflow
•
•
•

Load a workflow by clicking on “Workflow” ath the top of the screen	

Click on “Run”	

Select the input datas
Useful galaxy sites
•

Public main galaxy site (user disk quotas 250GB for registered users, maximum concurrent jobs: 8)	


•
•

Test galaxy site (beta site for galaxy main instance)	


•
•

http://hongiiv.tistory.com/701	


Galaxy를 이용한 SNP 분석 (Korean)	


•
•

https://wiki.galaxyproject.org/Learn	


Galaxy를 이용한 NGS 분석 (Korean)	


•
•

https://test.galaxyproject.org/	


Galaxy screen cast and tutorials	


•
•

https://usegalaxy.org/	


http://hongiiv.tistory.com/652	


Galaxy를 이용한 부시맨 genome 분석 (Korean)	


•

http://hongiiv.tistory.com/655
Acknowledgements:
YoungGi Kim	

HanKyu Choi	

WanPyo Hong	

KangJung Kim

Thank you

Más contenido relacionado

La actualidad más candente

Next-Generation Sequencing an Intro to Tech and Applications: NGS Tech Overvi...
Next-Generation Sequencing an Intro to Tech and Applications: NGS Tech Overvi...Next-Generation Sequencing an Intro to Tech and Applications: NGS Tech Overvi...
Next-Generation Sequencing an Intro to Tech and Applications: NGS Tech Overvi...QIAGEN
 
NGS data formats and analyses
NGS data formats and analysesNGS data formats and analyses
NGS data formats and analysesrjorton
 
RNA-seq differential expression analysis
RNA-seq differential expression analysisRNA-seq differential expression analysis
RNA-seq differential expression analysismikaelhuss
 
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...VHIR Vall d’Hebron Institut de Recerca
 
Whole Genome Sequencing Analysis
Whole Genome Sequencing AnalysisWhole Genome Sequencing Analysis
Whole Genome Sequencing AnalysisEfi Athieniti
 
Designing of-primer-for-human-foxp2-gene
Designing of-primer-for-human-foxp2-geneDesigning of-primer-for-human-foxp2-gene
Designing of-primer-for-human-foxp2-geneDh Sani
 
Introduction to Galaxy and RNA-Seq
Introduction to Galaxy and RNA-SeqIntroduction to Galaxy and RNA-Seq
Introduction to Galaxy and RNA-SeqEnis Afgan
 
NGS Introduction and Technology Overview (UEB-UAT Bioinformatics Course - Ses...
NGS Introduction and Technology Overview (UEB-UAT Bioinformatics Course - Ses...NGS Introduction and Technology Overview (UEB-UAT Bioinformatics Course - Ses...
NGS Introduction and Technology Overview (UEB-UAT Bioinformatics Course - Ses...VHIR Vall d’Hebron Institut de Recerca
 
So you want to do a: RNAseq experiment, Differential Gene Expression Analysis
So you want to do a: RNAseq experiment, Differential Gene Expression AnalysisSo you want to do a: RNAseq experiment, Differential Gene Expression Analysis
So you want to do a: RNAseq experiment, Differential Gene Expression AnalysisUniversity of California, Davis
 
Microarray Data Analysis
Microarray Data AnalysisMicroarray Data Analysis
Microarray Data Analysisyuvraj404
 
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...VHIR Vall d’Hebron Institut de Recerca
 

La actualidad más candente (20)

Next-Generation Sequencing an Intro to Tech and Applications: NGS Tech Overvi...
Next-Generation Sequencing an Intro to Tech and Applications: NGS Tech Overvi...Next-Generation Sequencing an Intro to Tech and Applications: NGS Tech Overvi...
Next-Generation Sequencing an Intro to Tech and Applications: NGS Tech Overvi...
 
Pcr primer design
Pcr primer designPcr primer design
Pcr primer design
 
NGS data formats and analyses
NGS data formats and analysesNGS data formats and analyses
NGS data formats and analyses
 
RNA-seq differential expression analysis
RNA-seq differential expression analysisRNA-seq differential expression analysis
RNA-seq differential expression analysis
 
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
 
Molecular biology lecture
Molecular biology lectureMolecular biology lecture
Molecular biology lecture
 
Protein-protein interaction networks
Protein-protein interaction networksProtein-protein interaction networks
Protein-protein interaction networks
 
Whole Genome Sequencing Analysis
Whole Genome Sequencing AnalysisWhole Genome Sequencing Analysis
Whole Genome Sequencing Analysis
 
Designing of-primer-for-human-foxp2-gene
Designing of-primer-for-human-foxp2-geneDesigning of-primer-for-human-foxp2-gene
Designing of-primer-for-human-foxp2-gene
 
Introduction to Galaxy and RNA-Seq
Introduction to Galaxy and RNA-SeqIntroduction to Galaxy and RNA-Seq
Introduction to Galaxy and RNA-Seq
 
NGS Introduction and Technology Overview (UEB-UAT Bioinformatics Course - Ses...
NGS Introduction and Technology Overview (UEB-UAT Bioinformatics Course - Ses...NGS Introduction and Technology Overview (UEB-UAT Bioinformatics Course - Ses...
NGS Introduction and Technology Overview (UEB-UAT Bioinformatics Course - Ses...
 
Sequence alignment
Sequence alignmentSequence alignment
Sequence alignment
 
Whole exome sequencing(wes)
Whole exome sequencing(wes)Whole exome sequencing(wes)
Whole exome sequencing(wes)
 
So you want to do a: RNAseq experiment, Differential Gene Expression Analysis
So you want to do a: RNAseq experiment, Differential Gene Expression AnalysisSo you want to do a: RNAseq experiment, Differential Gene Expression Analysis
So you want to do a: RNAseq experiment, Differential Gene Expression Analysis
 
ChipSeq Data Analysis
ChipSeq Data AnalysisChipSeq Data Analysis
ChipSeq Data Analysis
 
Variant analysis and whole exome sequencing
Variant analysis and whole exome sequencingVariant analysis and whole exome sequencing
Variant analysis and whole exome sequencing
 
Microarray Data Analysis
Microarray Data AnalysisMicroarray Data Analysis
Microarray Data Analysis
 
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
 
Ngs intro_v6_public
 Ngs intro_v6_public Ngs intro_v6_public
Ngs intro_v6_public
 
Ion torrent sequencing
Ion torrent sequencingIon torrent sequencing
Ion torrent sequencing
 

Destacado

Genomics and BigData - case study
Genomics and BigData - case studyGenomics and BigData - case study
Genomics and BigData - case studyHong ChangBum
 
Detecting Somatic Mutations in Impure Cancer Sample - Ensemble Approach
Detecting Somatic Mutations in Impure Cancer Sample - Ensemble ApproachDetecting Somatic Mutations in Impure Cancer Sample - Ensemble Approach
Detecting Somatic Mutations in Impure Cancer Sample - Ensemble ApproachHong ChangBum
 
Detecting Somatic Mutation - Ensemble Approach
Detecting Somatic Mutation - Ensemble ApproachDetecting Somatic Mutation - Ensemble Approach
Detecting Somatic Mutation - Ensemble ApproachHong ChangBum
 
Molecular characterization of Pst isolates from Western Canada
Molecular characterization of Pst isolates from Western CanadaMolecular characterization of Pst isolates from Western Canada
Molecular characterization of Pst isolates from Western CanadaBorlaug Global Rust Initiative
 
New High Throughput Sequencing technologies at the Norwegian Sequencing Centr...
New High Throughput Sequencing technologies at the Norwegian Sequencing Centr...New High Throughput Sequencing technologies at the Norwegian Sequencing Centr...
New High Throughput Sequencing technologies at the Norwegian Sequencing Centr...Lex Nederbragt
 
140127 abrf interlaboratory study proposal
140127 abrf interlaboratory study proposal140127 abrf interlaboratory study proposal
140127 abrf interlaboratory study proposalGenomeInABottle
 
Aug2014 abrf interlaboratory study plans
Aug2014 abrf interlaboratory study plansAug2014 abrf interlaboratory study plans
Aug2014 abrf interlaboratory study plansGenomeInABottle
 
Molecular QC: Interpreting your Bioinformatics Pipeline
Molecular QC: Interpreting your Bioinformatics PipelineMolecular QC: Interpreting your Bioinformatics Pipeline
Molecular QC: Interpreting your Bioinformatics PipelineCandy Smellie
 
Dr. Douglas Marthaler - Use of Next Generation Sequencing for Whole Genome An...
Dr. Douglas Marthaler - Use of Next Generation Sequencing for Whole Genome An...Dr. Douglas Marthaler - Use of Next Generation Sequencing for Whole Genome An...
Dr. Douglas Marthaler - Use of Next Generation Sequencing for Whole Genome An...John Blue
 
Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016
Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016
Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016Prof. Wim Van Criekinge
 
A Survey of NGS Data Analysis on Hadoop
A Survey of NGS Data Analysis on HadoopA Survey of NGS Data Analysis on Hadoop
A Survey of NGS Data Analysis on HadoopChung-Tsai Su
 
NGS Targeted Enrichment Technology in Cancer Research: NGS Tech Overview Webi...
NGS Targeted Enrichment Technology in Cancer Research: NGS Tech Overview Webi...NGS Targeted Enrichment Technology in Cancer Research: NGS Tech Overview Webi...
NGS Targeted Enrichment Technology in Cancer Research: NGS Tech Overview Webi...QIAGEN
 
A different kettle of fish entirely: bioinformatic challenges and solutions f...
A different kettle of fish entirely: bioinformatic challenges and solutions f...A different kettle of fish entirely: bioinformatic challenges and solutions f...
A different kettle of fish entirely: bioinformatic challenges and solutions f...Lex Nederbragt
 
I Jornada Actualización en Genética Reproductiva y Fertilidad
I Jornada Actualización en Genética Reproductiva y Fertilidad I Jornada Actualización en Genética Reproductiva y Fertilidad
I Jornada Actualización en Genética Reproductiva y Fertilidad TECNALIA Research & Innovation
 
Knowing Your NGS Upstream: Alignment and Variants
Knowing Your NGS Upstream: Alignment and VariantsKnowing Your NGS Upstream: Alignment and Variants
Knowing Your NGS Upstream: Alignment and VariantsGolden Helix Inc
 
Next generation sequencing in preimplantation genetic screening (NGS in PGS)
Next generation sequencing in preimplantation genetic screening (NGS in PGS)Next generation sequencing in preimplantation genetic screening (NGS in PGS)
Next generation sequencing in preimplantation genetic screening (NGS in PGS)Mahidol University, Thailand
 

Destacado (20)

Genomics and BigData - case study
Genomics and BigData - case studyGenomics and BigData - case study
Genomics and BigData - case study
 
Detecting Somatic Mutations in Impure Cancer Sample - Ensemble Approach
Detecting Somatic Mutations in Impure Cancer Sample - Ensemble ApproachDetecting Somatic Mutations in Impure Cancer Sample - Ensemble Approach
Detecting Somatic Mutations in Impure Cancer Sample - Ensemble Approach
 
Workshop 2011
Workshop 2011Workshop 2011
Workshop 2011
 
Detecting Somatic Mutation - Ensemble Approach
Detecting Somatic Mutation - Ensemble ApproachDetecting Somatic Mutation - Ensemble Approach
Detecting Somatic Mutation - Ensemble Approach
 
RNAseq Analysis
RNAseq AnalysisRNAseq Analysis
RNAseq Analysis
 
Molecular characterization of Pst isolates from Western Canada
Molecular characterization of Pst isolates from Western CanadaMolecular characterization of Pst isolates from Western Canada
Molecular characterization of Pst isolates from Western Canada
 
New High Throughput Sequencing technologies at the Norwegian Sequencing Centr...
New High Throughput Sequencing technologies at the Norwegian Sequencing Centr...New High Throughput Sequencing technologies at the Norwegian Sequencing Centr...
New High Throughput Sequencing technologies at the Norwegian Sequencing Centr...
 
140127 abrf interlaboratory study proposal
140127 abrf interlaboratory study proposal140127 abrf interlaboratory study proposal
140127 abrf interlaboratory study proposal
 
Aug2014 abrf interlaboratory study plans
Aug2014 abrf interlaboratory study plansAug2014 abrf interlaboratory study plans
Aug2014 abrf interlaboratory study plans
 
Molecular QC: Interpreting your Bioinformatics Pipeline
Molecular QC: Interpreting your Bioinformatics PipelineMolecular QC: Interpreting your Bioinformatics Pipeline
Molecular QC: Interpreting your Bioinformatics Pipeline
 
Dr. Douglas Marthaler - Use of Next Generation Sequencing for Whole Genome An...
Dr. Douglas Marthaler - Use of Next Generation Sequencing for Whole Genome An...Dr. Douglas Marthaler - Use of Next Generation Sequencing for Whole Genome An...
Dr. Douglas Marthaler - Use of Next Generation Sequencing for Whole Genome An...
 
Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016
Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016
Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016
 
2016 iHT2 San Diego Health IT Summit
2016 iHT2 San Diego Health IT Summit2016 iHT2 San Diego Health IT Summit
2016 iHT2 San Diego Health IT Summit
 
Biz model for ion proton dna sequencer
Biz model for ion proton dna sequencerBiz model for ion proton dna sequencer
Biz model for ion proton dna sequencer
 
A Survey of NGS Data Analysis on Hadoop
A Survey of NGS Data Analysis on HadoopA Survey of NGS Data Analysis on Hadoop
A Survey of NGS Data Analysis on Hadoop
 
NGS Targeted Enrichment Technology in Cancer Research: NGS Tech Overview Webi...
NGS Targeted Enrichment Technology in Cancer Research: NGS Tech Overview Webi...NGS Targeted Enrichment Technology in Cancer Research: NGS Tech Overview Webi...
NGS Targeted Enrichment Technology in Cancer Research: NGS Tech Overview Webi...
 
A different kettle of fish entirely: bioinformatic challenges and solutions f...
A different kettle of fish entirely: bioinformatic challenges and solutions f...A different kettle of fish entirely: bioinformatic challenges and solutions f...
A different kettle of fish entirely: bioinformatic challenges and solutions f...
 
I Jornada Actualización en Genética Reproductiva y Fertilidad
I Jornada Actualización en Genética Reproductiva y Fertilidad I Jornada Actualización en Genética Reproductiva y Fertilidad
I Jornada Actualización en Genética Reproductiva y Fertilidad
 
Knowing Your NGS Upstream: Alignment and Variants
Knowing Your NGS Upstream: Alignment and VariantsKnowing Your NGS Upstream: Alignment and Variants
Knowing Your NGS Upstream: Alignment and Variants
 
Next generation sequencing in preimplantation genetic screening (NGS in PGS)
Next generation sequencing in preimplantation genetic screening (NGS in PGS)Next generation sequencing in preimplantation genetic screening (NGS in PGS)
Next generation sequencing in preimplantation genetic screening (NGS in PGS)
 

Similar a Galaxy RNA-Seq Analysis: Tuxedo Protocol

Big data solution for ngs data analysis
Big data solution for ngs data analysisBig data solution for ngs data analysis
Big data solution for ngs data analysisYun Lung Li
 
"Einstürzenden Neudaten: Building an Analytics Engine from Scratch", Tobias J...
"Einstürzenden Neudaten: Building an Analytics Engine from Scratch", Tobias J..."Einstürzenden Neudaten: Building an Analytics Engine from Scratch", Tobias J...
"Einstürzenden Neudaten: Building an Analytics Engine from Scratch", Tobias J...Dataconomy Media
 
Benchmarking Solr Performance at Scale
Benchmarking Solr Performance at ScaleBenchmarking Solr Performance at Scale
Benchmarking Solr Performance at Scalethelabdude
 
Cassandra
CassandraCassandra
Cassandraexsuns
 
Ceph used in Cancer Research at OICR
Ceph used in Cancer Research at OICRCeph used in Cancer Research at OICR
Ceph used in Cancer Research at OICRCeph Community
 
On-boarding with JanusGraph Performance
On-boarding with JanusGraph PerformanceOn-boarding with JanusGraph Performance
On-boarding with JanusGraph PerformanceChin Huang
 
Chicago Kafka Meetup
Chicago Kafka MeetupChicago Kafka Meetup
Chicago Kafka MeetupCliff Gilmore
 
Bioinfo ngs data format visualization v2
Bioinfo ngs data format visualization v2Bioinfo ngs data format visualization v2
Bioinfo ngs data format visualization v2Li Shen
 
Cassandra Tools and Distributed Administration (Jeffrey Berger, Knewton) | C*...
Cassandra Tools and Distributed Administration (Jeffrey Berger, Knewton) | C*...Cassandra Tools and Distributed Administration (Jeffrey Berger, Knewton) | C*...
Cassandra Tools and Distributed Administration (Jeffrey Berger, Knewton) | C*...DataStax
 
Next-generation sequencing data format and visualization with ngs.plot 2015
Next-generation sequencing data format and visualization with ngs.plot 2015Next-generation sequencing data format and visualization with ngs.plot 2015
Next-generation sequencing data format and visualization with ngs.plot 2015Li Shen
 
Real-Time Big Data with Storm, Kafka and GigaSpaces
Real-Time Big Data with Storm, Kafka and GigaSpacesReal-Time Big Data with Storm, Kafka and GigaSpaces
Real-Time Big Data with Storm, Kafka and GigaSpacesOleksii Diagiliev
 
Scaling Genomic Analyses
Scaling Genomic AnalysesScaling Genomic Analyses
Scaling Genomic Analysesfnothaft
 
Performance Test Driven Development with Oracle Coherence
Performance Test Driven Development with Oracle CoherencePerformance Test Driven Development with Oracle Coherence
Performance Test Driven Development with Oracle Coherencearagozin
 
Seqr - Protein Sequence Search: Presented by Lianyi Han, Medical Science & Co...
Seqr - Protein Sequence Search: Presented by Lianyi Han, Medical Science & Co...Seqr - Protein Sequence Search: Presented by Lianyi Han, Medical Science & Co...
Seqr - Protein Sequence Search: Presented by Lianyi Han, Medical Science & Co...Lucidworks
 
Next-generation sequencing format and visualization with ngs.plot
Next-generation sequencing format and visualization with ngs.plotNext-generation sequencing format and visualization with ngs.plot
Next-generation sequencing format and visualization with ngs.plotLi Shen
 
Testing data and metadata backends with ClawIO
Testing data and metadata backends with ClawIOTesting data and metadata backends with ClawIO
Testing data and metadata backends with ClawIOHugo González Labrador
 
Serverless on OpenStack with Docker Swarm, Mistral, and StackStorm
Serverless on OpenStack with Docker Swarm, Mistral, and StackStormServerless on OpenStack with Docker Swarm, Mistral, and StackStorm
Serverless on OpenStack with Docker Swarm, Mistral, and StackStormDmitri Zimine
 
Badneedles
BadneedlesBadneedles
Badneedlesdimisec
 
Introduction to Storm
Introduction to Storm Introduction to Storm
Introduction to Storm Chandler Huang
 

Similar a Galaxy RNA-Seq Analysis: Tuxedo Protocol (20)

Big data solution for ngs data analysis
Big data solution for ngs data analysisBig data solution for ngs data analysis
Big data solution for ngs data analysis
 
"Einstürzenden Neudaten: Building an Analytics Engine from Scratch", Tobias J...
"Einstürzenden Neudaten: Building an Analytics Engine from Scratch", Tobias J..."Einstürzenden Neudaten: Building an Analytics Engine from Scratch", Tobias J...
"Einstürzenden Neudaten: Building an Analytics Engine from Scratch", Tobias J...
 
Benchmarking Solr Performance at Scale
Benchmarking Solr Performance at ScaleBenchmarking Solr Performance at Scale
Benchmarking Solr Performance at Scale
 
Cassandra
CassandraCassandra
Cassandra
 
Ceph used in Cancer Research at OICR
Ceph used in Cancer Research at OICRCeph used in Cancer Research at OICR
Ceph used in Cancer Research at OICR
 
XSEDE15_PhastaGateway
XSEDE15_PhastaGatewayXSEDE15_PhastaGateway
XSEDE15_PhastaGateway
 
On-boarding with JanusGraph Performance
On-boarding with JanusGraph PerformanceOn-boarding with JanusGraph Performance
On-boarding with JanusGraph Performance
 
Chicago Kafka Meetup
Chicago Kafka MeetupChicago Kafka Meetup
Chicago Kafka Meetup
 
Bioinfo ngs data format visualization v2
Bioinfo ngs data format visualization v2Bioinfo ngs data format visualization v2
Bioinfo ngs data format visualization v2
 
Cassandra Tools and Distributed Administration (Jeffrey Berger, Knewton) | C*...
Cassandra Tools and Distributed Administration (Jeffrey Berger, Knewton) | C*...Cassandra Tools and Distributed Administration (Jeffrey Berger, Knewton) | C*...
Cassandra Tools and Distributed Administration (Jeffrey Berger, Knewton) | C*...
 
Next-generation sequencing data format and visualization with ngs.plot 2015
Next-generation sequencing data format and visualization with ngs.plot 2015Next-generation sequencing data format and visualization with ngs.plot 2015
Next-generation sequencing data format and visualization with ngs.plot 2015
 
Real-Time Big Data with Storm, Kafka and GigaSpaces
Real-Time Big Data with Storm, Kafka and GigaSpacesReal-Time Big Data with Storm, Kafka and GigaSpaces
Real-Time Big Data with Storm, Kafka and GigaSpaces
 
Scaling Genomic Analyses
Scaling Genomic AnalysesScaling Genomic Analyses
Scaling Genomic Analyses
 
Performance Test Driven Development with Oracle Coherence
Performance Test Driven Development with Oracle CoherencePerformance Test Driven Development with Oracle Coherence
Performance Test Driven Development with Oracle Coherence
 
Seqr - Protein Sequence Search: Presented by Lianyi Han, Medical Science & Co...
Seqr - Protein Sequence Search: Presented by Lianyi Han, Medical Science & Co...Seqr - Protein Sequence Search: Presented by Lianyi Han, Medical Science & Co...
Seqr - Protein Sequence Search: Presented by Lianyi Han, Medical Science & Co...
 
Next-generation sequencing format and visualization with ngs.plot
Next-generation sequencing format and visualization with ngs.plotNext-generation sequencing format and visualization with ngs.plot
Next-generation sequencing format and visualization with ngs.plot
 
Testing data and metadata backends with ClawIO
Testing data and metadata backends with ClawIOTesting data and metadata backends with ClawIO
Testing data and metadata backends with ClawIO
 
Serverless on OpenStack with Docker Swarm, Mistral, and StackStorm
Serverless on OpenStack with Docker Swarm, Mistral, and StackStormServerless on OpenStack with Docker Swarm, Mistral, and StackStorm
Serverless on OpenStack with Docker Swarm, Mistral, and StackStorm
 
Badneedles
BadneedlesBadneedles
Badneedles
 
Introduction to Storm
Introduction to Storm Introduction to Storm
Introduction to Storm
 

Más de Hong ChangBum

통계유전학워크샵
통계유전학워크샵통계유전학워크샵
통계유전학워크샵Hong ChangBum
 
Genome Wide SNP Analysis for Inferring the Population Structure and Genetic H...
Genome Wide SNP Analysis for Inferring the Population Structure and Genetic H...Genome Wide SNP Analysis for Inferring the Population Structure and Genetic H...
Genome Wide SNP Analysis for Inferring the Population Structure and Genetic H...Hong ChangBum
 
BioSMACK - Linux Live CD for GWAS
BioSMACK - Linux Live CD for GWASBioSMACK - Linux Live CD for GWAS
BioSMACK - Linux Live CD for GWASHong ChangBum
 
Next-generation genomics: an integrative approach
Next-generation genomics: an integrative approachNext-generation genomics: an integrative approach
Next-generation genomics: an integrative approachHong ChangBum
 
worldwide population
worldwide populationworldwide population
worldwide populationHong ChangBum
 
RSS & Bioinformatics
RSS & BioinformaticsRSS & Bioinformatics
RSS & BioinformaticsHong ChangBum
 
Perspectives of identifying Korean genetic variations
Perspectives of identifying Korean genetic variationsPerspectives of identifying Korean genetic variations
Perspectives of identifying Korean genetic variationsHong ChangBum
 
Genome Browser based on Google Maps API
Genome Browser based on Google Maps APIGenome Browser based on Google Maps API
Genome Browser based on Google Maps APIHong ChangBum
 
Korean Database of Genomic Variants
Korean Database of Genomic VariantsKorean Database of Genomic Variants
Korean Database of Genomic VariantsHong ChangBum
 
Next Generation bio Research Infra
Next Generation bio Research InfraNext Generation bio Research Infra
Next Generation bio Research InfraHong ChangBum
 

Más de Hong ChangBum (20)

Demo chapter3
Demo chapter3Demo chapter3
Demo chapter3
 
통계유전학워크샵
통계유전학워크샵통계유전학워크샵
통계유전학워크샵
 
Genome Wide SNP Analysis for Inferring the Population Structure and Genetic H...
Genome Wide SNP Analysis for Inferring the Population Structure and Genetic H...Genome Wide SNP Analysis for Inferring the Population Structure and Genetic H...
Genome Wide SNP Analysis for Inferring the Population Structure and Genetic H...
 
BioSMACK - Linux Live CD for GWAS
BioSMACK - Linux Live CD for GWASBioSMACK - Linux Live CD for GWAS
BioSMACK - Linux Live CD for GWAS
 
Next-generation genomics: an integrative approach
Next-generation genomics: an integrative approachNext-generation genomics: an integrative approach
Next-generation genomics: an integrative approach
 
How to genome
How to genomeHow to genome
How to genome
 
worldwide population
worldwide populationworldwide population
worldwide population
 
RSS & Bioinformatics
RSS & BioinformaticsRSS & Bioinformatics
RSS & Bioinformatics
 
Perspectives of identifying Korean genetic variations
Perspectives of identifying Korean genetic variationsPerspectives of identifying Korean genetic variations
Perspectives of identifying Korean genetic variations
 
Genome Browser based on Google Maps API
Genome Browser based on Google Maps APIGenome Browser based on Google Maps API
Genome Browser based on Google Maps API
 
Korean Database of Genomic Variants
Korean Database of Genomic VariantsKorean Database of Genomic Variants
Korean Database of Genomic Variants
 
Dt Ccompanieslist
Dt CcompanieslistDt Ccompanieslist
Dt Ccompanieslist
 
DTC Companies List
DTC Companies ListDTC Companies List
DTC Companies List
 
My Project
My ProjectMy Project
My Project
 
Genome Browser
Genome BrowserGenome Browser
Genome Browser
 
GenomeBrowser
GenomeBrowserGenomeBrowser
GenomeBrowser
 
Desire
DesireDesire
Desire
 
Next Generation bio Research Infra
Next Generation bio Research InfraNext Generation bio Research Infra
Next Generation bio Research Infra
 
Cluster Drm
Cluster DrmCluster Drm
Cluster Drm
 
Cluster Drm
Cluster DrmCluster Drm
Cluster Drm
 

Último

Call Girls Siliguri Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Siliguri Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Siliguri Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Siliguri Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Call Girls Ooty Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Ooty Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Ooty Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Ooty Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Night 7k to 12k Chennai City Center Call Girls 👉👉 7427069034⭐⭐ 100% Genuine E...
Night 7k to 12k Chennai City Center Call Girls 👉👉 7427069034⭐⭐ 100% Genuine E...Night 7k to 12k Chennai City Center Call Girls 👉👉 7427069034⭐⭐ 100% Genuine E...
Night 7k to 12k Chennai City Center Call Girls 👉👉 7427069034⭐⭐ 100% Genuine E...hotbabesbook
 
Call Girls Bareilly Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Bareilly Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Bareilly Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Bareilly Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Call Girls Aurangabad Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Aurangabad Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Aurangabad Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Aurangabad Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Call Girls in Delhi Triveni Complex Escort Service(🔝))/WhatsApp 97111⇛47426
Call Girls in Delhi Triveni Complex Escort Service(🔝))/WhatsApp 97111⇛47426Call Girls in Delhi Triveni Complex Escort Service(🔝))/WhatsApp 97111⇛47426
Call Girls in Delhi Triveni Complex Escort Service(🔝))/WhatsApp 97111⇛47426jennyeacort
 
Top Rated Hyderabad Call Girls Erragadda ⟟ 9332606886 ⟟ Call Me For Genuine ...
Top Rated  Hyderabad Call Girls Erragadda ⟟ 9332606886 ⟟ Call Me For Genuine ...Top Rated  Hyderabad Call Girls Erragadda ⟟ 9332606886 ⟟ Call Me For Genuine ...
Top Rated Hyderabad Call Girls Erragadda ⟟ 9332606886 ⟟ Call Me For Genuine ...chandars293
 
All Time Service Available Call Girls Marine Drive 📳 9820252231 For 18+ VIP C...
All Time Service Available Call Girls Marine Drive 📳 9820252231 For 18+ VIP C...All Time Service Available Call Girls Marine Drive 📳 9820252231 For 18+ VIP C...
All Time Service Available Call Girls Marine Drive 📳 9820252231 For 18+ VIP C...Arohi Goyal
 
Call Girls Varanasi Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Varanasi Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Varanasi Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Varanasi Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Night 7k to 12k Navi Mumbai Call Girl Photo 👉 BOOK NOW 9833363713 👈 ♀️ night ...
Night 7k to 12k Navi Mumbai Call Girl Photo 👉 BOOK NOW 9833363713 👈 ♀️ night ...Night 7k to 12k Navi Mumbai Call Girl Photo 👉 BOOK NOW 9833363713 👈 ♀️ night ...
Night 7k to 12k Navi Mumbai Call Girl Photo 👉 BOOK NOW 9833363713 👈 ♀️ night ...aartirawatdelhi
 
♛VVIP Hyderabad Call Girls Chintalkunta🖕7001035870🖕Riya Kappor Top Call Girl ...
♛VVIP Hyderabad Call Girls Chintalkunta🖕7001035870🖕Riya Kappor Top Call Girl ...♛VVIP Hyderabad Call Girls Chintalkunta🖕7001035870🖕Riya Kappor Top Call Girl ...
♛VVIP Hyderabad Call Girls Chintalkunta🖕7001035870🖕Riya Kappor Top Call Girl ...astropune
 
Call Girls Faridabad Just Call 9907093804 Top Class Call Girl Service Available
Call Girls Faridabad Just Call 9907093804 Top Class Call Girl Service AvailableCall Girls Faridabad Just Call 9907093804 Top Class Call Girl Service Available
Call Girls Faridabad Just Call 9907093804 Top Class Call Girl Service AvailableDipal Arora
 
Call Girls Guntur Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Guntur  Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Guntur  Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Guntur Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
The Most Attractive Hyderabad Call Girls Kothapet 𖠋 9332606886 𖠋 Will You Mis...
The Most Attractive Hyderabad Call Girls Kothapet 𖠋 9332606886 𖠋 Will You Mis...The Most Attractive Hyderabad Call Girls Kothapet 𖠋 9332606886 𖠋 Will You Mis...
The Most Attractive Hyderabad Call Girls Kothapet 𖠋 9332606886 𖠋 Will You Mis...chandars293
 
Best Rate (Hyderabad) Call Girls Jahanuma ⟟ 8250192130 ⟟ High Class Call Girl...
Best Rate (Hyderabad) Call Girls Jahanuma ⟟ 8250192130 ⟟ High Class Call Girl...Best Rate (Hyderabad) Call Girls Jahanuma ⟟ 8250192130 ⟟ High Class Call Girl...
Best Rate (Hyderabad) Call Girls Jahanuma ⟟ 8250192130 ⟟ High Class Call Girl...astropune
 
Call Girls Haridwar Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Haridwar Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Haridwar Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Haridwar Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Call Girls Agra Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Agra Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Agra Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Agra Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
VIP Hyderabad Call Girls Bahadurpally 7877925207 ₹5000 To 25K With AC Room 💚😋
VIP Hyderabad Call Girls Bahadurpally 7877925207 ₹5000 To 25K With AC Room 💚😋VIP Hyderabad Call Girls Bahadurpally 7877925207 ₹5000 To 25K With AC Room 💚😋
VIP Hyderabad Call Girls Bahadurpally 7877925207 ₹5000 To 25K With AC Room 💚😋TANUJA PANDEY
 
Call Girls Nagpur Just Call 9907093804 Top Class Call Girl Service Available
Call Girls Nagpur Just Call 9907093804 Top Class Call Girl Service AvailableCall Girls Nagpur Just Call 9907093804 Top Class Call Girl Service Available
Call Girls Nagpur Just Call 9907093804 Top Class Call Girl Service AvailableDipal Arora
 

Último (20)

Call Girls Siliguri Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Siliguri Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Siliguri Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Siliguri Just Call 8250077686 Top Class Call Girl Service Available
 
Call Girls Ooty Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Ooty Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Ooty Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Ooty Just Call 8250077686 Top Class Call Girl Service Available
 
Call Girls in Gagan Vihar (delhi) call me [🔝 9953056974 🔝] escort service 24X7
Call Girls in Gagan Vihar (delhi) call me [🔝  9953056974 🔝] escort service 24X7Call Girls in Gagan Vihar (delhi) call me [🔝  9953056974 🔝] escort service 24X7
Call Girls in Gagan Vihar (delhi) call me [🔝 9953056974 🔝] escort service 24X7
 
Night 7k to 12k Chennai City Center Call Girls 👉👉 7427069034⭐⭐ 100% Genuine E...
Night 7k to 12k Chennai City Center Call Girls 👉👉 7427069034⭐⭐ 100% Genuine E...Night 7k to 12k Chennai City Center Call Girls 👉👉 7427069034⭐⭐ 100% Genuine E...
Night 7k to 12k Chennai City Center Call Girls 👉👉 7427069034⭐⭐ 100% Genuine E...
 
Call Girls Bareilly Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Bareilly Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Bareilly Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Bareilly Just Call 8250077686 Top Class Call Girl Service Available
 
Call Girls Aurangabad Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Aurangabad Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Aurangabad Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Aurangabad Just Call 8250077686 Top Class Call Girl Service Available
 
Call Girls in Delhi Triveni Complex Escort Service(🔝))/WhatsApp 97111⇛47426
Call Girls in Delhi Triveni Complex Escort Service(🔝))/WhatsApp 97111⇛47426Call Girls in Delhi Triveni Complex Escort Service(🔝))/WhatsApp 97111⇛47426
Call Girls in Delhi Triveni Complex Escort Service(🔝))/WhatsApp 97111⇛47426
 
Top Rated Hyderabad Call Girls Erragadda ⟟ 9332606886 ⟟ Call Me For Genuine ...
Top Rated  Hyderabad Call Girls Erragadda ⟟ 9332606886 ⟟ Call Me For Genuine ...Top Rated  Hyderabad Call Girls Erragadda ⟟ 9332606886 ⟟ Call Me For Genuine ...
Top Rated Hyderabad Call Girls Erragadda ⟟ 9332606886 ⟟ Call Me For Genuine ...
 
All Time Service Available Call Girls Marine Drive 📳 9820252231 For 18+ VIP C...
All Time Service Available Call Girls Marine Drive 📳 9820252231 For 18+ VIP C...All Time Service Available Call Girls Marine Drive 📳 9820252231 For 18+ VIP C...
All Time Service Available Call Girls Marine Drive 📳 9820252231 For 18+ VIP C...
 
Call Girls Varanasi Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Varanasi Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Varanasi Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Varanasi Just Call 8250077686 Top Class Call Girl Service Available
 
Night 7k to 12k Navi Mumbai Call Girl Photo 👉 BOOK NOW 9833363713 👈 ♀️ night ...
Night 7k to 12k Navi Mumbai Call Girl Photo 👉 BOOK NOW 9833363713 👈 ♀️ night ...Night 7k to 12k Navi Mumbai Call Girl Photo 👉 BOOK NOW 9833363713 👈 ♀️ night ...
Night 7k to 12k Navi Mumbai Call Girl Photo 👉 BOOK NOW 9833363713 👈 ♀️ night ...
 
♛VVIP Hyderabad Call Girls Chintalkunta🖕7001035870🖕Riya Kappor Top Call Girl ...
♛VVIP Hyderabad Call Girls Chintalkunta🖕7001035870🖕Riya Kappor Top Call Girl ...♛VVIP Hyderabad Call Girls Chintalkunta🖕7001035870🖕Riya Kappor Top Call Girl ...
♛VVIP Hyderabad Call Girls Chintalkunta🖕7001035870🖕Riya Kappor Top Call Girl ...
 
Call Girls Faridabad Just Call 9907093804 Top Class Call Girl Service Available
Call Girls Faridabad Just Call 9907093804 Top Class Call Girl Service AvailableCall Girls Faridabad Just Call 9907093804 Top Class Call Girl Service Available
Call Girls Faridabad Just Call 9907093804 Top Class Call Girl Service Available
 
Call Girls Guntur Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Guntur  Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Guntur  Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Guntur Just Call 8250077686 Top Class Call Girl Service Available
 
The Most Attractive Hyderabad Call Girls Kothapet 𖠋 9332606886 𖠋 Will You Mis...
The Most Attractive Hyderabad Call Girls Kothapet 𖠋 9332606886 𖠋 Will You Mis...The Most Attractive Hyderabad Call Girls Kothapet 𖠋 9332606886 𖠋 Will You Mis...
The Most Attractive Hyderabad Call Girls Kothapet 𖠋 9332606886 𖠋 Will You Mis...
 
Best Rate (Hyderabad) Call Girls Jahanuma ⟟ 8250192130 ⟟ High Class Call Girl...
Best Rate (Hyderabad) Call Girls Jahanuma ⟟ 8250192130 ⟟ High Class Call Girl...Best Rate (Hyderabad) Call Girls Jahanuma ⟟ 8250192130 ⟟ High Class Call Girl...
Best Rate (Hyderabad) Call Girls Jahanuma ⟟ 8250192130 ⟟ High Class Call Girl...
 
Call Girls Haridwar Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Haridwar Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Haridwar Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Haridwar Just Call 8250077686 Top Class Call Girl Service Available
 
Call Girls Agra Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Agra Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Agra Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Agra Just Call 8250077686 Top Class Call Girl Service Available
 
VIP Hyderabad Call Girls Bahadurpally 7877925207 ₹5000 To 25K With AC Room 💚😋
VIP Hyderabad Call Girls Bahadurpally 7877925207 ₹5000 To 25K With AC Room 💚😋VIP Hyderabad Call Girls Bahadurpally 7877925207 ₹5000 To 25K With AC Room 💚😋
VIP Hyderabad Call Girls Bahadurpally 7877925207 ₹5000 To 25K With AC Room 💚😋
 
Call Girls Nagpur Just Call 9907093804 Top Class Call Girl Service Available
Call Girls Nagpur Just Call 9907093804 Top Class Call Girl Service AvailableCall Girls Nagpur Just Call 9907093804 Top Class Call Girl Service Available
Call Girls Nagpur Just Call 9907093804 Top Class Call Girl Service Available
 

Galaxy RNA-Seq Analysis: Tuxedo Protocol

  • 1. Galaxy RNA-Seq Analysis: Tuxedo Protocol ChangBum Hong, KT Bioinformatics, GenomeCloud SCIC genome-cloud.com This work is licensed under the Creative Commons Attribution-NonCommercialShareAlike 3.0 New Zealand License. To view a copy of this license, visit http:// creativecommons.org/licenses/by-nc-sa/3.0/nz/ or send a letter to Creative Commons, 171 Second Street, Suite 300, San Francisco, California, 94105, USA.
  • 2. Introduction • RNA-Seq • • • Transcriptome assembly • Qualitative identification of expressed sequence Differential expression analysis • Quantitative measurement of transcript expression RNA-Seq Applications • Annotation: Identify novel genes, transcripts, exons, splicing events, ncRNAs • • Detecting RNA editing and SNPs Measurements: RNA quantification and differential gene expression
  • 3. Experimental design • What are my goals? • Transcriptome assembly? • Differential expression analysis? • Identify rare transcripts? • What are the characteristics of my system? • Large, complex genome? • Introns and high degree of alternative splicing? • No reference genome or transcriptome?
  • 5. Sequencing • Platforms • Library preparation • Multiplexing • Sequence reads • File names • Fastq format(Formats vary) • 4 lines per read Illumina Read ID
  • 6. Data Quality Control • Data Quality Assessment • Identify poor/bad sample • Identify contaminates • Trimming: remove bad bases from read • Filtering: remove bad reads from library
  • 7. Read Mapping • Alignment algorithm must be • fast • able to handle SNPs, indels, and sequencing errors • allow for introns for reference genome alignment • Input • fastq read library • reference genome index • insert size mean and stddev(for paired-end libraries) • Output • SAM (text) / BAM (binary) alignment files
  • 8. Differential Expression • Cuffdiff (Cufflinks package) • Pairwise comparisons • Differnetial gene, transcript, and primary transcript expression • Easy to use, well documented • Input: transcriptome, SAM/BAM read alignments
  • 9. Transcriptome Assembly • RNA-Seq • Reference genome • Reference transcriptome • RNA-Seq • Reference genome • No reference transcriptome • RNA-Seq • No reference genome • No reference transcriptome
  • 11. Combining tools in a pipeline • Linux Command-line Tools • Shell script, Makefile • GUI Based pipeline • DNANexus • SevenBridegs Genomics • Galaxy • Open Source • Wrapper for command line utilites • Workflows • Save all steps you did in your analysis • Return the entire analysis on a new dataset • Share your workflow with other people
  • 12. How to use Galaxy? GALAXY MAIN: User disk quotas 250GB for registered users, maximum concurrent jobs: 8 NO WAIT TIMES NO NO JOB STORAGE SUBMISSION QUOTAS LIMITS NO DATA TRANSFER BOTTLENECKS NO IT EXPERIENCE REQUIRED NO REQUIRED INFRASTRUCTURE COST GALAXY MAIN Free LOCAL GALAXY Free ? CLOUD GALAXY (AMAZON) 동일사양 대비 약 2배 (KT의) SLIPSTREAM GALAXY $19,995 (2천2백만원) KT GenomeCloud GALAXY 시간당 740원 부터
  • 13. Outline of tutorial • Starting Galaxy • Mapping with Tophat • Workflows • Visualizing alignment with IGV • Computing differential expression with cuffdiff • Cuffdiff visuaalization with CummeRbund
  • 14.
  • 15. Starting Galaxy • Tutorial Dataset • Accessing Galaxy • Import files for one sample into current history • Set file attributes • Run FastQC
  • 16. Tutorial Dataset • FASTQ files (fastq): Sequence Reads • Reference (fasta): Genome Sequence (galaxy default) • Geneset (GTF / GFF3): Reference Geneset • Bowtie2 index: Reference index files for Bowtie2 (galaxy default)
  • 17. Tutorial Dataset Reference & Gene sets • Ensembl • http://www.ensembl.org/info/data/ftp/index.html
  • 18. Tutorial Dataset Reference & Gene sets •illumina iGenomes • The iGenomes are a collection of reference sequences and annotation files for commonly analyzed organisms. The files have been downloaded from Ensembl, NCBI, or UCSC, and chromosome names have been changed to be simple and consistent with their download source. Each iGenome is available as a compressed file that contains sequences and annotation files for a single genomic build of an organism. • http://support.illumina.com/sequencing/sequencing_software/igenome.ilmn
  • 19. Tutorial Dataset Sequencing data •Sequencing data (Drosophila melanogaster) • Gene Expression Omnibus at accession GSE32038 • http://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE32038
  • 20. Biological replicates vs. technical replicates Technical Replicates Biological Replicates
  • 21. Accessing Galaxy • • Open a web browser and navigate to Galaxy website usegalaxy.org or www.genome-cloud.com Log in with username and password select galaxy service GenomeCloud (genome-cloud.com)
  • 22. when your galaxy is ready you will recive the e-mail access the galaxy via public ip address you can register via user menu > register Center pane Tools pane History pane
  • 23. Import files • • Open a web browser and navigate to Galaxy website usegalaxy.org or www.genome-cloud.com Log in with username and password example fastq and gtf files are located in shared data > RNA-Seq with Drosophila melanogaster import data into your history panel (read to analysis)
  • 24. Set file attributes • • In the history pane click on the pencil icon Enter “fastqsanger” (It will takes time) Sanger Phread+33 fastqsanger (cassava 1.8 ▲ ) Ilumina 1.3 Phread+64 fastqillunina (cassava 1.8 ▼) Solexa Solexa+64 fastqsolexa Tophat options --solexa-quals: Use the Solexa scale for quality values in FASTQ files --solexa1.3-quals: Phred64/Illumina 1.3~1.5 ! BWA options -l : The input is in the Illumina 1.3+ read format (quality equals ASCII-64) ! GenomeCloud (g-Analysis)
  • 25. Error probability Quality Score Encoding CASAVA 1.8.2 Quality Score (or Q-score)
  • 26. Run FastQC • • Load the FastQC tool from the tool pane Set the input file (repeat this step on the C1, C2 all piar files)
  • 27. wait running done error Galaxy status When fastqc has finished running, click on the eye on the FastQC output file to display
  • 28. illumina (in-house data) IonTorrent (in-house data) illumina (good dataset in FastQC homepage) illumina (bad dataset in FastQC homepage) Per base sequence quality illumina (in-house data) IonTorrent (in-house data) illumina (good dataset in FastQC homepage) illumina (bad dataset in FastQC homepage) Per sequence quality score illumina (in-house data) IonTorrent (in-house data) illumina (good dataset in FastQC homepage) Per base sequence content illumina (bad dataset in FastQC homepage)
  • 29. illumina (in-house data) IonTorrent (in-house data) illumina (good dataset in FastQC homepage) illumina (bad dataset in FastQC homepage) Per base GC content illumina (in-house data) IonTorrent (in-house data) illumina (good dataset in FastQC homepage) illumina (bad dataset in FastQC homepage) Per sequence GC content illumina (in-house data) IonTorrent (in-house data) illumina (good dataset in FastQC homepage) Per base N content illumina (bad dataset in FastQC homepage)
  • 30. illumina (in-house data) IonTorrent (in-house data) illumina (good dataset in FastQC homepage) illumina (bad dataset in FastQC homepage) Sequence Length Distribution illumina (in-house data) IonTorrent (in-house data) illumina (good dataset in FastQC homepage) Sequence Duplication Levels illumina (bad dataset in FastQC homepage)
  • 31.
  • 32. Mapping with Tophat • Initial Tophat run • Determine insert size • Rerun Tophat with correct insert size • Review mapping statistics
  • 33. Initial Tophat run • • • Use Full Tophat paramters Paired-end FASTQ files, Select reference genome, Use Own Juctions(Yes), Use Gene Annotation Model(Yes) Gene Model Anntations (use GFF file)
  • 34. Determine insert size • Load the insert size tool “NGS: Picard (beta) -> Insertion size meterics”
  • 35. Determine insert size • • Click “eye” icon Identify the MIN_INSERT_SIZE (198)
  • 36. Rerun Tophat • • • Click any one of the Tophat2 output files in the history panne Click on the circular blue arrow icon Change the “Mean Inner Distance between Mate Pairs” (198)
  • 37. Tophat Output • • unmapped.bam (BAM) • junctions.bed (BED): list BED track of junctions reported by Tophat where each junction consists of two connected BED blocks where each block is as long as the max overhang of nay read spanning juction • deletions.bed (BED): mentions the last genomic base before the deletion • insertions.bed (BED): mentions the first genomic base of deletion accepted_hits.bam (BAM): a list of read alignments in BAM/SAM format
  • 38. Load files into IGV • • • • Click on the “accepted hits” file in the history pane Click on the “display with IGV web current” A file named “igv.jnlp” will be downloaded by your browser Open with text editor copy BAM file location
  • 39. IGV with Housekeeping gene http://www.sabiosciences.com/rt_pcr_product/HTML/PADM-000Z.html
  • 40. Load files into IGV • • Enter “Act42A” in the search box to view the reads aligning Right-click on the coverage track and select “Set Data Range” (max value to 4372) Housekeeping gene: Act42A Set max value
  • 42. Keyword: regucalcin (calcium-binding protein) this gene has four isoforms
  • 43. Load files into Trackster • • • Click on the “accepted hits” file in the history pane Click on the graph icon and select “Trackster” Select bam files
  • 44. drag into new group move to regucalcin gene create new group ‘Add group’
  • 46. Run cuffdiff • • • Load the Cuffdiff tool: “NGS:RNA Analysis->Cuffdiff ” Perform replicate analysis(Yes) Add new Group / Add new Replicate
  • 47. Cuffdiff output • Genes: gene differential FPKM • Isoforms: Transcript differential FPKM • CDS: Coding sequence differential FPKM
  • 48. • • View and filter cuffdiff output Differential Gene Expression (DGE) Filter out genes with significant change in expression with a log fold-change of at least 1 “C14 == ‘yes’ and abs(c10)>1” in the “With following condition” text box
  • 49.
  • 50. • • Cuffdiff visualization with CummeRbund Load the CummeRbund tool: NGS:RNA Analysis->cummerbund Plot type: Density, check the “Replicates” box
  • 51. Samples have similar density distribution(density plot) Samples cluster by expression condition (MDS / PCA plot) Samples cluster by experimental condition (Dendogram)
  • 52. Volcano Differential analysis results for regucalcin Expression plot shows clear differences in the expression of regucalcin across conditions C1 and C2 (four alternative isoforms) Scatter plots highlight general similarities and specific outliers between conditions C1 and C2
  • 53. Extract workflow from current history • Click on the small gear icon and select “Extract Workflow”
  • 54. Edit workflow • • Click on “Workflow” at the top of the Galaxy window Move the elements of the workflow
  • 55. Run workflow • • • Load a workflow by clicking on “Workflow” ath the top of the screen Click on “Run” Select the input datas
  • 56.
  • 57. Useful galaxy sites • Public main galaxy site (user disk quotas 250GB for registered users, maximum concurrent jobs: 8) • • Test galaxy site (beta site for galaxy main instance) • • http://hongiiv.tistory.com/701 Galaxy를 이용한 SNP 분석 (Korean) • • https://wiki.galaxyproject.org/Learn Galaxy를 이용한 NGS 분석 (Korean) • • https://test.galaxyproject.org/ Galaxy screen cast and tutorials • • https://usegalaxy.org/ http://hongiiv.tistory.com/652 Galaxy를 이용한 부시맨 genome 분석 (Korean) • http://hongiiv.tistory.com/655