SlideShare a Scribd company logo
1 of 84
Download to read offline
Date
Maarten Leerkes PhD
Genome Analysis Specialist
Bioinformatics and Computational Biosciences Branch
Office of Cyber Infrastructure and Computational Biology
RNA-seq with R-bioconductor
Part 1.
BCBB: A Branch Devoted to Bioinformatics and
Computational Biosciences
§  Researchers’ time is increasingly important
§  BCBB saves our collaborators time and effort
§  Researchers speed projects to completion using
BCBB consultation and development services
§  No need to hire extra post docs or use external
consultants or developers
2
BCBB Staff
3
Bioinformatics
Software
Developers
Computational
Biologists
Project Managers
and Analysts
Contact BCBB…
§  “NIH Users: Access a menu of BCBB services on
the NIAID Intranet:
•  http://bioinformatics.niaid.nih.gov/
§  Outside of NIH –
•  search “BCBB” on the NIAID Public Internet Page:
www.niaid.nih.gov
– or – use this direct link
§  Email us at:
•  ScienceApps@niaid.nih.gov
4
Seminar Follow-Up Site
§  For access to past recordings, handouts, slides visit this site from the
NIH network: http://collab.niaid.nih.gov/sites/research/SIG/
Bioinformatics/
5
1. Select a
Subject Matter
View:
•  Seminar Details
•  Handout and
Reference Docs
•  Relevant Links
•  Seminar
Recording Links
2. Select a
Topic
Recommended Browsers:
•  IE for Windows,
•  Safari for Mac (Firefox on a
Mac is incompatible with
NIH Authentication
technology)
Login
•  If prompted to log in use
“NIH” in front of your
username
ScienceApps@niaid.nih.gov
https://bioinformatics.niaid.nih.gov (NIAID intranet)
Structural Biology
Phylogenetics
Statistics
Sequence Analysis
Molecular Dynamics
Microarray Analysis
BCBB: A Branch Devoted to Bioinformatics and
Computational Biosciences
Topics
§  What is R
§  What is Bioconductor
§  What is RNAseq
7
What is R
§  R is a programming language and software
environment for statistical computing and graphics.
The R language is widely used among statisticians
and data miners for developing statistical software[2]
[3] and data analysis.
8
What is R
§  R is an implementation of the S programming
language combined with lexical scoping semantics
inspired by Scheme. S was created by John
Chambers while at Bell Labs. There are some
important differences, but much of the code written for
S runs unaltered.
9
What is R
§  R is a GNU project. The source code for the R
software environment is written primarily in C, Fortran,
and R. R is freely available under the GNU General
Public License, and pre-compiled binary versions are
provided for various operating systems. R uses a
command line interface; there are also several
graphical front-ends for it.
10
DOWNLOAD R FROM CRAN:
http://cran.r-project.org/
11
12
Topics
§  What is R
§  What is Bioconductor
§  What is RNAseq
13
What is bioconductor
14
Topics
§  What is R
§  What is Bioconductor
§  What is RNAseq
15
What is RNAseq
§  RNA-seq (RNA Sequencing), also called Whole
Transcriptome Shotgun Sequencing (WTSS), is a
technology that uses the capabilities of next-
generation sequencing to reveal a snapshot of
RNA presence and quantity from a genome at a
given moment in time.
16
Topics
§  What is R
§  What is Bioconductor
§  What is RNAseq
§  Comes together in: RNA-seq with R-bioconductor
17
Different kinds of objects in R
§  Objects.
§  The following data objects exist in R:
§  vectors
§  lists
§  arrays
§  matrices
§  tables
§  data frames
§  Some of these are more important than others. And
there are more.
18
19
20
A data frame is used for storing data
tables. It is a list of vectors of equal length.
§  A data frame is a table, or two-dimensional array-like
structure, in which each column contains
measurements on one variable, and each row
contains one case. As we shall see, a "case" is not
necessarily the same as an experimental subject or
unit, although they are often the same.
21
Combine list of data frames into single data frame, add
column with list index: list of vectors of equal length.
22
Methods: software carpentry:
http://swcarpentry.github.io/r-novice-inflammation/01-starting-with-data.html
23
Rna-seq with R
Demo: easyRNAseq
Source(“c:windowsmynamerna_seq_tutorial.R”)
source("/vol/maarten/rna_seq_tutorial2.R")
http://bioscholar.com/genomics/bioconductor-packages-analysis-rna-seq-data/
Current working directory cwd
25
Topics: start R
26
Topics: use R console and R command
line
27
Topics: use R console and R command
line
28
Topics: use R console and R command
line
29
Topics: use R console and R command
line
30
Topics: use R console and R command
line
31
Topics
§  What is R
§  What is Bioconductor
§  What is RNAseq
32
Sequencing by synthesis
§  Intro to Sequencing by Synthesis:
§  https://www.youtube.com/watch?v=HMyCqWhwB8E
34
FASTQ read with 50nt in Illumina format (ASCII_BASE=33).
There are always four lines per read.
35
36
Paired end: read 1 in one fastq file
37
Paired end: read 2 in another fastq file
38
Numerous	
  possible	
  analysis	
  strategies	
  
§  There	
  is	
  no	
  one	
  ‘correct’	
  way	
  to	
  
analyze	
  RNA-­‐seq	
  data	
  	
  
§  Two	
  major	
  branches	
  
•  Direct	
  alignment	
  of	
  reads	
  
(spliced	
  or	
  unspliced)	
  to	
  genome	
  
or	
  transcriptome	
  
•  Assembly	
  of	
  reads	
  followed	
  by	
  
alignment*	
  
*Assembly is the only option when working with a creature with no genome sequence,
alignment of contigs may be to ESTs, cDNAs etc
or transcriptome
Image from Haas & Zody, 2010
40
Illumina clonal
expansion
followed by image
processing
Pile up sequences to reference genome
42
SAM format: what are sam/bam files
http://biobits.org/samtools_primer.html
43
44
RNA	
  sequencing:	
  abundance	
  comparisons	
  
between	
  two	
  or	
  more	
  condi9ons	
  /	
  phenotypes	
  
CondiCon	
  1	
  
(normal	
  Cssue)	
  
CondiCon	
  2	
  
(diseased	
  Cssue)	
  
Isolate	
  RNAs	
  
Sequence	
  ends	
  
100s	
  of	
  millions	
  of	
  paired	
  reads	
  
10s	
  of	
  billions	
  bases	
  of	
  sequence	
  
Generate	
  cDNA,	
  fragment,	
  
size	
  select,	
  add	
  linkers	
  Samples	
  of	
  interest	
  
Map	
  to	
  genome,	
  
transcriptome,	
  and	
  
predicted	
  exon	
  
junc9ons	
  
Downstream	
  analysis	
  
Compare two samples for abundance
differences
46
Transcript abundances differ in pile-up
47
Genes have ‘structure’, solve by mapping
§  This leads to for example analysis of intron-exon
structure
Genes and transcripts
Currrent
paradigm:
“cuff-suit”
50
Common	
  analysis	
  goals	
  of	
  RNA-­‐Seq	
  	
  analysis	
  	
  
(what	
  can	
  you	
  ask	
  of	
  the	
  data?)	
  
§  Gene	
  expression	
  and	
  differenCal	
  expression	
  
§  AlternaCve	
  expression	
  analysis	
  
§  Transcript	
  discovery	
  and	
  annotaCon	
  
§  Allele	
  specific	
  expression	
  
•  RelaCng	
  to	
  SNPs	
  or	
  mutaCons	
  
§  MutaCon	
  discovery	
  
§  Fusion	
  detecCon	
  
§  RNA	
  ediCng	
  
Back	
  to	
  the	
  demo	
  
§  IntroducCon	
  to	
  RNA	
  sequencing	
  
§  RaConale	
  for	
  RNA	
  sequencing	
  (versus	
  DNA	
  sequencing)	
  
§  Hands	
  on	
  tutorial	
  
Rna-seq with R
Demo: easyRNAseq
Source(“c:windowsmynamerna_seq_tutorial.R”)
source("/vol/maarten/rna_seq_tutorial2.R")
http://bioscholar.com/genomics/bioconductor-packages-analysis-rna-seq-data/
54
Deseq and DEseq2
§  method based on the negative binomial distribution,
with variance and mean linked by local regression
§  DEseq2:
§  No demo scripts available yet:
§  http://www.bioconductor.org/packages/release/bioc/
vignettes/DESeq2/inst/doc/DESeq2.pdf
55
The empirical frequency distribution of the hybridization signal intensity values for
Affymetrix microarray hybridization data for normal yeast cell genes/ORFs (Jelinsky
and Samson 1999).
Kuznetsov V A et al. Genetics 2002;161:1321-1332
Copyright © 2002 by the Genetics Society of America
Empirical relative frequency distributions of the gene expression levels.
Kuznetsov V A et al. Genetics 2002;161:1321-1332
Copyright © 2002 by the Genetics Society of America
58
59
Empirical (black dots) and fitted (red lines)
dispersion values plotted against the mean of the
normalised counts.
60
Plot of normalised mean versus log2 fold change
for the contrast untreated versus treated.
61
Histogram of p-values from the call to
nbinomTest.
62
MvA plot for the
contrast“treated”vs.“untreated”, using two
treated and only one untreated sample.
63
Heatmaps showing the expression data of
the 30 most highly expressed genes
64
Heatmap showing the Euclidean distances between the
samples as calculated from the variance stabilising
transformation of the count data.
65
Biological effects of condition and libType
66
Mean expression versus log2 fold change
plot. Significant hits (at padj<0.1) are
coloured in red.
67
Per-gene dispersion estimates (shown by
points) and the fitted mean- dispersion
function (red line).
68
Differential exon usage
§  Detecting spliced isoform usage by exon-level
expression analysis
69
Types of splicing
70
expression estimates from a call to testForDEU.
Shown in red is the exon that showed significant
differential exon usage.
71
Normalized counts. As in previous Figure,
with normalized count values of each exon
in each of the samples.
72
estimated effects, but after subtraction of
overall changes in gene expression.
73
Dependence of dispersion on the mean
74
75
Distributions of Fold changes of exon
usage
76
77
Resources: RNA-Seq workflow, gene-level
exploratory analysis and differential expression
78
79
Outline	
  
§  IntroducCon	
  to	
  RNA	
  sequencing	
  
§  RaConale	
  for	
  RNA	
  sequencing	
  (versus	
  DNA	
  sequencing)	
  
§  Hands	
  on	
  tutorial	
  
§  hQp://swcarpentry.github.io/r-­‐novice-­‐inflammaCon/	
  
§  hQp://swcarpentry.github.io/r-­‐novice-­‐inflammaCon/02-­‐func-­‐R.html	
  
§  hQp://www.bioconductor.org/help/workflows/	
  
§  hQp://www.bioconductor.org/packages/release/data/experiment/
html/parathyroidSE.html	
  
§  hQp://www.bioconductor.org/help/workflows/rnaseqGene/	
  
About bioconductor
High-throughput sequence analysis with R and Bioconductor:
http://www.bioconductor.org/help/course-materials/2013/useR2013/
Bioconductor-tutorial.pdf
http://bioconductor.org/packages/2.13/data/experiment/vignettes/
RnaSeqTutorial/inst/doc/RnaSeqTutorial.pdf
Also helpful: http://www.bioconductor.org/help/course-materials/2002/
Summer02Course/Labs/basics.pdf
http://www.nature.com/nprot/journal/v8/n9/
pdf/nprot.2013.099.pdf
82
The End
84

More Related Content

What's hot

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
 
Illumina GAIIx for high throughput sequencing
Illumina GAIIx for high throughput sequencingIllumina GAIIx for high throughput sequencing
Illumina GAIIx for high throughput sequencingCristian Cosentino, PhD
 
BITS - Introduction to comparative genomics
BITS - Introduction to comparative genomicsBITS - Introduction to comparative genomics
BITS - Introduction to comparative genomicsBITS
 
Next Generation Sequencing of DNA
Next Generation Sequencing of DNANext Generation Sequencing of DNA
Next Generation Sequencing of DNAmaryamshah13
 
De novo genome assembly - T.Seemann - IMB winter school 2016 - brisbane, au ...
De novo genome assembly  - T.Seemann - IMB winter school 2016 - brisbane, au ...De novo genome assembly  - T.Seemann - IMB winter school 2016 - brisbane, au ...
De novo genome assembly - T.Seemann - IMB winter school 2016 - brisbane, au ...Torsten Seemann
 
Primer Designing Practical
Primer Designing PracticalPrimer Designing Practical
Primer Designing PracticalSabahat Ali
 
NGS data formats and analyses
NGS data formats and analysesNGS data formats and analyses
NGS data formats and analysesrjorton
 
Introduction to RNA-seq
Introduction to RNA-seqIntroduction to RNA-seq
Introduction to RNA-seqPaul Gardner
 
Next generation sequencing
Next generation sequencingNext generation sequencing
Next generation sequencingPALANIANANTH.S
 
Maxam-Gilbert method of DNA sequencing
Maxam-Gilbert method of DNA sequencingMaxam-Gilbert method of DNA sequencing
Maxam-Gilbert method of DNA sequencingmaryamshah13
 
Basics of bioinformatics
Basics of bioinformaticsBasics of bioinformatics
Basics of bioinformaticsAbhishek Vatsa
 
Ion torrent and SOLiD Sequencing Techniques
Ion torrent and SOLiD Sequencing Techniques Ion torrent and SOLiD Sequencing Techniques
Ion torrent and SOLiD Sequencing Techniques fikrem24yahoocom6261
 

What's hot (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...
 
Illumina GAIIx for high throughput sequencing
Illumina GAIIx for high throughput sequencingIllumina GAIIx for high throughput sequencing
Illumina GAIIx for high throughput sequencing
 
BITS - Introduction to comparative genomics
BITS - Introduction to comparative genomicsBITS - Introduction to comparative genomics
BITS - Introduction to comparative genomics
 
Next Generation Sequencing of DNA
Next Generation Sequencing of DNANext Generation Sequencing of DNA
Next Generation Sequencing of DNA
 
222397 lecture 16 17
222397 lecture 16 17222397 lecture 16 17
222397 lecture 16 17
 
Express sequence tags
Express sequence tagsExpress sequence tags
Express sequence tags
 
De novo genome assembly - T.Seemann - IMB winter school 2016 - brisbane, au ...
De novo genome assembly  - T.Seemann - IMB winter school 2016 - brisbane, au ...De novo genome assembly  - T.Seemann - IMB winter school 2016 - brisbane, au ...
De novo genome assembly - T.Seemann - IMB winter school 2016 - brisbane, au ...
 
Primer Designing Practical
Primer Designing PracticalPrimer Designing Practical
Primer Designing Practical
 
NGS data formats and analyses
NGS data formats and analysesNGS data formats and analyses
NGS data formats and analyses
 
Introduction to RNA-seq
Introduction to RNA-seqIntroduction to RNA-seq
Introduction to RNA-seq
 
Protein-protein interaction networks
Protein-protein interaction networksProtein-protein interaction networks
Protein-protein interaction networks
 
Biological networks - building and visualizing
Biological networks - building and visualizingBiological networks - building and visualizing
Biological networks - building and visualizing
 
Next generation sequencing
Next generation sequencingNext generation sequencing
Next generation sequencing
 
Maxam-Gilbert method of DNA sequencing
Maxam-Gilbert method of DNA sequencingMaxam-Gilbert method of DNA sequencing
Maxam-Gilbert method of DNA sequencing
 
Rna seq
Rna seqRna seq
Rna seq
 
Maximum parsimony
Maximum parsimonyMaximum parsimony
Maximum parsimony
 
Basics of bioinformatics
Basics of bioinformaticsBasics of bioinformatics
Basics of bioinformatics
 
Ion torrent and SOLiD Sequencing Techniques
Ion torrent and SOLiD Sequencing Techniques Ion torrent and SOLiD Sequencing Techniques
Ion torrent and SOLiD Sequencing Techniques
 
Jan2016 pac bio giab
Jan2016 pac bio giabJan2016 pac bio giab
Jan2016 pac bio giab
 
PHYLOGENETICS WITH MEGA
PHYLOGENETICS WITH MEGAPHYLOGENETICS WITH MEGA
PHYLOGENETICS WITH MEGA
 

Viewers also liked (6)

Design of experiments
Design of experiments Design of experiments
Design of experiments
 
Network components and biological network construction methods
Network components and biological network construction methodsNetwork components and biological network construction methods
Network components and biological network construction methods
 
Cytoscape
CytoscapeCytoscape
Cytoscape
 
Biological networks
Biological networksBiological networks
Biological networks
 
Variant analysis and whole exome sequencing
Variant analysis and whole exome sequencingVariant analysis and whole exome sequencing
Variant analysis and whole exome sequencing
 
ChIP-seq Theory
ChIP-seq TheoryChIP-seq Theory
ChIP-seq Theory
 

Similar to RNA-Seq with R-Bioconductor

RNA sequencing analysis tutorial with NGS
RNA sequencing analysis tutorial with NGSRNA sequencing analysis tutorial with NGS
RNA sequencing analysis tutorial with NGSHAMNAHAMNA8
 
Dgaston dec-06-2012
Dgaston dec-06-2012Dgaston dec-06-2012
Dgaston dec-06-2012Dan Gaston
 
rnaseq2015-02-18-170327193409.pdf
rnaseq2015-02-18-170327193409.pdfrnaseq2015-02-18-170327193409.pdf
rnaseq2015-02-18-170327193409.pdfPushpendra83
 
RNASeq - Analysis Pipeline for Differential Expression
RNASeq - Analysis Pipeline for Differential ExpressionRNASeq - Analysis Pipeline for Differential Expression
RNASeq - Analysis Pipeline for Differential ExpressionJatinder Singh
 
Talk ABRF 2015 (Gunnar Rätsch)
Talk ABRF 2015 (Gunnar Rätsch)Talk ABRF 2015 (Gunnar Rätsch)
Talk ABRF 2015 (Gunnar Rätsch)Gunnar Rätsch
 
Bioinformatics class ppt arifuzzaman
Bioinformatics class ppt arifuzzamanBioinformatics class ppt arifuzzaman
Bioinformatics class ppt arifuzzamanSardar Arifuzzaman
 
Enabling Large Scale Sequencing Studies through Science as a Service
Enabling Large Scale Sequencing Studies through Science as a ServiceEnabling Large Scale Sequencing Studies through Science as a Service
Enabling Large Scale Sequencing Studies through Science as a ServiceJustin Johnson
 
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...GenomeInABottle
 
exRNA Data Analysis Tools in the Genboree Workbench
exRNA Data Analysis Tools in the Genboree WorkbenchexRNA Data Analysis Tools in the Genboree Workbench
exRNA Data Analysis Tools in the Genboree Workbenchexrna
 
Mastering RNA-Seq (NGS Data Analysis) - A Critical Approach To Transcriptomic...
Mastering RNA-Seq (NGS Data Analysis) - A Critical Approach To Transcriptomic...Mastering RNA-Seq (NGS Data Analysis) - A Critical Approach To Transcriptomic...
Mastering RNA-Seq (NGS Data Analysis) - A Critical Approach To Transcriptomic...Elia Brodsky
 
Detecting and Quantifying Low Level Variants in Sanger Sequencing Traces
Detecting and Quantifying Low Level Variants in Sanger Sequencing TracesDetecting and Quantifying Low Level Variants in Sanger Sequencing Traces
Detecting and Quantifying Low Level Variants in Sanger Sequencing TracesThermo Fisher Scientific
 
The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...
The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...
The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...Mackenna Galicia
 
OVium Bioinformatic Solutions
OVium Bioinformatic SolutionsOVium Bioinformatic Solutions
OVium Bioinformatic SolutionsOVium Solutions
 
Exploring DNA/RNA-Seq Analysis Results with Golden Helix GenomeBrowse and SVS
Exploring DNA/RNA-Seq Analysis Results with Golden Helix GenomeBrowse and SVSExploring DNA/RNA-Seq Analysis Results with Golden Helix GenomeBrowse and SVS
Exploring DNA/RNA-Seq Analysis Results with Golden Helix GenomeBrowse and SVSGolden Helix Inc
 
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
 

Similar to RNA-Seq with R-Bioconductor (20)

NGS: Mapping and de novo assembly
NGS: Mapping and de novo assemblyNGS: Mapping and de novo assembly
NGS: Mapping and de novo assembly
 
RNA sequencing analysis tutorial with NGS
RNA sequencing analysis tutorial with NGSRNA sequencing analysis tutorial with NGS
RNA sequencing analysis tutorial with NGS
 
Dgaston dec-06-2012
Dgaston dec-06-2012Dgaston dec-06-2012
Dgaston dec-06-2012
 
rnaseq2015-02-18-170327193409.pdf
rnaseq2015-02-18-170327193409.pdfrnaseq2015-02-18-170327193409.pdf
rnaseq2015-02-18-170327193409.pdf
 
RNASeq - Analysis Pipeline for Differential Expression
RNASeq - Analysis Pipeline for Differential ExpressionRNASeq - Analysis Pipeline for Differential Expression
RNASeq - Analysis Pipeline for Differential Expression
 
Use of NCBI Databases in qPCR Assay Design
Use of NCBI Databases in qPCR Assay DesignUse of NCBI Databases in qPCR Assay Design
Use of NCBI Databases in qPCR Assay Design
 
Talk ABRF 2015 (Gunnar Rätsch)
Talk ABRF 2015 (Gunnar Rätsch)Talk ABRF 2015 (Gunnar Rätsch)
Talk ABRF 2015 (Gunnar Rätsch)
 
Bioinformatics
BioinformaticsBioinformatics
Bioinformatics
 
Bioinformatics class ppt arifuzzaman
Bioinformatics class ppt arifuzzamanBioinformatics class ppt arifuzzaman
Bioinformatics class ppt arifuzzaman
 
Enabling Large Scale Sequencing Studies through Science as a Service
Enabling Large Scale Sequencing Studies through Science as a ServiceEnabling Large Scale Sequencing Studies through Science as a Service
Enabling Large Scale Sequencing Studies through Science as a Service
 
Molecular Biology Software Links
Molecular Biology Software LinksMolecular Biology Software Links
Molecular Biology Software Links
 
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
 
exRNA Data Analysis Tools in the Genboree Workbench
exRNA Data Analysis Tools in the Genboree WorkbenchexRNA Data Analysis Tools in the Genboree Workbench
exRNA Data Analysis Tools in the Genboree Workbench
 
Introduction to Apollo for i5k
Introduction to Apollo for i5kIntroduction to Apollo for i5k
Introduction to Apollo for i5k
 
Mastering RNA-Seq (NGS Data Analysis) - A Critical Approach To Transcriptomic...
Mastering RNA-Seq (NGS Data Analysis) - A Critical Approach To Transcriptomic...Mastering RNA-Seq (NGS Data Analysis) - A Critical Approach To Transcriptomic...
Mastering RNA-Seq (NGS Data Analysis) - A Critical Approach To Transcriptomic...
 
Detecting and Quantifying Low Level Variants in Sanger Sequencing Traces
Detecting and Quantifying Low Level Variants in Sanger Sequencing TracesDetecting and Quantifying Low Level Variants in Sanger Sequencing Traces
Detecting and Quantifying Low Level Variants in Sanger Sequencing Traces
 
The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...
The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...
The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...
 
OVium Bioinformatic Solutions
OVium Bioinformatic SolutionsOVium Bioinformatic Solutions
OVium Bioinformatic Solutions
 
Exploring DNA/RNA-Seq Analysis Results with Golden Helix GenomeBrowse and SVS
Exploring DNA/RNA-Seq Analysis Results with Golden Helix GenomeBrowse and SVSExploring DNA/RNA-Seq Analysis Results with Golden Helix GenomeBrowse and SVS
Exploring DNA/RNA-Seq Analysis Results with Golden Helix GenomeBrowse and SVS
 
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
 

More from Bioinformatics and Computational Biosciences Branch

More from Bioinformatics and Computational Biosciences Branch (20)

Hong_Celine_ES_workshop.pptx
Hong_Celine_ES_workshop.pptxHong_Celine_ES_workshop.pptx
Hong_Celine_ES_workshop.pptx
 
Virus Sequence Alignment and Phylogenetic Analysis 2019
Virus Sequence Alignment and Phylogenetic Analysis 2019Virus Sequence Alignment and Phylogenetic Analysis 2019
Virus Sequence Alignment and Phylogenetic Analysis 2019
 
Nephele 2.0: How to get the most out of your Nephele results
Nephele 2.0: How to get the most out of your Nephele resultsNephele 2.0: How to get the most out of your Nephele results
Nephele 2.0: How to get the most out of your Nephele results
 
Introduction to METAGENOTE
Introduction to METAGENOTE Introduction to METAGENOTE
Introduction to METAGENOTE
 
Intro to homology modeling
Intro to homology modelingIntro to homology modeling
Intro to homology modeling
 
Protein fold recognition and ab_initio modeling
Protein fold recognition and ab_initio modelingProtein fold recognition and ab_initio modeling
Protein fold recognition and ab_initio modeling
 
Homology modeling: Modeller
Homology modeling: ModellerHomology modeling: Modeller
Homology modeling: Modeller
 
Protein docking
Protein dockingProtein docking
Protein docking
 
Protein function prediction
Protein function predictionProtein function prediction
Protein function prediction
 
Protein structure prediction with a focus on Rosetta
Protein structure prediction with a focus on RosettaProtein structure prediction with a focus on Rosetta
Protein structure prediction with a focus on Rosetta
 
UNIX Basics and Cluster Computing
UNIX Basics and Cluster ComputingUNIX Basics and Cluster Computing
UNIX Basics and Cluster Computing
 
Statistical applications in GraphPad Prism
Statistical applications in GraphPad PrismStatistical applications in GraphPad Prism
Statistical applications in GraphPad Prism
 
Intro to JMP for statistics
Intro to JMP for statisticsIntro to JMP for statistics
Intro to JMP for statistics
 
Categorical models
Categorical modelsCategorical models
Categorical models
 
Better graphics in R
Better graphics in RBetter graphics in R
Better graphics in R
 
Automating biostatistics workflows using R-based webtools
Automating biostatistics workflows using R-based webtoolsAutomating biostatistics workflows using R-based webtools
Automating biostatistics workflows using R-based webtools
 
Overview of statistical tests: Data handling and data quality (Part II)
Overview of statistical tests: Data handling and data quality (Part II)Overview of statistical tests: Data handling and data quality (Part II)
Overview of statistical tests: Data handling and data quality (Part II)
 
Overview of statistics: Statistical testing (Part I)
Overview of statistics: Statistical testing (Part I)Overview of statistics: Statistical testing (Part I)
Overview of statistics: Statistical testing (Part I)
 
GraphPad Prism: Curve fitting
GraphPad Prism: Curve fittingGraphPad Prism: Curve fitting
GraphPad Prism: Curve fitting
 
Appendix: Crash course in R and BioConductor
Appendix: Crash course in R and BioConductorAppendix: Crash course in R and BioConductor
Appendix: Crash course in R and BioConductor
 

Recently uploaded

Chemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdfChemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdfSumit Kumar yadav
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTSérgio Sacani
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)PraveenaKalaiselvan1
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​kaibalyasahoo82800
 
Animal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptxAnimal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptxUmerFayaz5
 
Biopesticide (2).pptx .This slides helps to know the different types of biop...
Biopesticide (2).pptx  .This slides helps to know the different types of biop...Biopesticide (2).pptx  .This slides helps to know the different types of biop...
Biopesticide (2).pptx .This slides helps to know the different types of biop...RohitNehra6
 
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43bNightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43bSérgio Sacani
 
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Sérgio Sacani
 
Pests of mustard_Identification_Management_Dr.UPR.pdf
Pests of mustard_Identification_Management_Dr.UPR.pdfPests of mustard_Identification_Management_Dr.UPR.pdf
Pests of mustard_Identification_Management_Dr.UPR.pdfPirithiRaju
 
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdfPests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdfPirithiRaju
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfSumit Kumar yadav
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxgindu3009
 
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls AgencyHire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls AgencySheetal Arora
 
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service 🪡
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service  🪡CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service  🪡
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service 🪡anilsa9823
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)Areesha Ahmad
 
Zoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfZoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfSumit Kumar yadav
 
Chromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATINChromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATINsankalpkumarsahoo174
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisDiwakar Mishra
 
Forensic Biology & Its biological significance.pdf
Forensic Biology & Its biological significance.pdfForensic Biology & Its biological significance.pdf
Forensic Biology & Its biological significance.pdfrohankumarsinghrore1
 
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRStunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRDelhi Call girls
 

Recently uploaded (20)

Chemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdfChemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdf
 
Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOST
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​
 
Animal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptxAnimal Communication- Auditory and Visual.pptx
Animal Communication- Auditory and Visual.pptx
 
Biopesticide (2).pptx .This slides helps to know the different types of biop...
Biopesticide (2).pptx  .This slides helps to know the different types of biop...Biopesticide (2).pptx  .This slides helps to know the different types of biop...
Biopesticide (2).pptx .This slides helps to know the different types of biop...
 
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43bNightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
 
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
 
Pests of mustard_Identification_Management_Dr.UPR.pdf
Pests of mustard_Identification_Management_Dr.UPR.pdfPests of mustard_Identification_Management_Dr.UPR.pdf
Pests of mustard_Identification_Management_Dr.UPR.pdf
 
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdfPests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
Pests of cotton_Borer_Pests_Binomics_Dr.UPR.pdf
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdf
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptx
 
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls AgencyHire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
Hire 💕 9907093804 Hooghly Call Girls Service Call Girls Agency
 
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service 🪡
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service  🪡CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service  🪡
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service 🪡
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)
 
Zoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfZoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdf
 
Chromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATINChromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATIN
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
 
Forensic Biology & Its biological significance.pdf
Forensic Biology & Its biological significance.pdfForensic Biology & Its biological significance.pdf
Forensic Biology & Its biological significance.pdf
 
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCRStunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
Stunning ➥8448380779▻ Call Girls In Panchshil Enclave Delhi NCR
 

RNA-Seq with R-Bioconductor

  • 1. Date Maarten Leerkes PhD Genome Analysis Specialist Bioinformatics and Computational Biosciences Branch Office of Cyber Infrastructure and Computational Biology RNA-seq with R-bioconductor Part 1.
  • 2. BCBB: A Branch Devoted to Bioinformatics and Computational Biosciences §  Researchers’ time is increasingly important §  BCBB saves our collaborators time and effort §  Researchers speed projects to completion using BCBB consultation and development services §  No need to hire extra post docs or use external consultants or developers 2
  • 4. Contact BCBB… §  “NIH Users: Access a menu of BCBB services on the NIAID Intranet: •  http://bioinformatics.niaid.nih.gov/ §  Outside of NIH – •  search “BCBB” on the NIAID Public Internet Page: www.niaid.nih.gov – or – use this direct link §  Email us at: •  ScienceApps@niaid.nih.gov 4
  • 5. Seminar Follow-Up Site §  For access to past recordings, handouts, slides visit this site from the NIH network: http://collab.niaid.nih.gov/sites/research/SIG/ Bioinformatics/ 5 1. Select a Subject Matter View: •  Seminar Details •  Handout and Reference Docs •  Relevant Links •  Seminar Recording Links 2. Select a Topic Recommended Browsers: •  IE for Windows, •  Safari for Mac (Firefox on a Mac is incompatible with NIH Authentication technology) Login •  If prompted to log in use “NIH” in front of your username
  • 6. ScienceApps@niaid.nih.gov https://bioinformatics.niaid.nih.gov (NIAID intranet) Structural Biology Phylogenetics Statistics Sequence Analysis Molecular Dynamics Microarray Analysis BCBB: A Branch Devoted to Bioinformatics and Computational Biosciences
  • 7. Topics §  What is R §  What is Bioconductor §  What is RNAseq 7
  • 8. What is R §  R is a programming language and software environment for statistical computing and graphics. The R language is widely used among statisticians and data miners for developing statistical software[2] [3] and data analysis. 8
  • 9. What is R §  R is an implementation of the S programming language combined with lexical scoping semantics inspired by Scheme. S was created by John Chambers while at Bell Labs. There are some important differences, but much of the code written for S runs unaltered. 9
  • 10. What is R §  R is a GNU project. The source code for the R software environment is written primarily in C, Fortran, and R. R is freely available under the GNU General Public License, and pre-compiled binary versions are provided for various operating systems. R uses a command line interface; there are also several graphical front-ends for it. 10
  • 11. DOWNLOAD R FROM CRAN: http://cran.r-project.org/ 11
  • 12. 12
  • 13. Topics §  What is R §  What is Bioconductor §  What is RNAseq 13
  • 15. Topics §  What is R §  What is Bioconductor §  What is RNAseq 15
  • 16. What is RNAseq §  RNA-seq (RNA Sequencing), also called Whole Transcriptome Shotgun Sequencing (WTSS), is a technology that uses the capabilities of next- generation sequencing to reveal a snapshot of RNA presence and quantity from a genome at a given moment in time. 16
  • 17. Topics §  What is R §  What is Bioconductor §  What is RNAseq §  Comes together in: RNA-seq with R-bioconductor 17
  • 18. Different kinds of objects in R §  Objects. §  The following data objects exist in R: §  vectors §  lists §  arrays §  matrices §  tables §  data frames §  Some of these are more important than others. And there are more. 18
  • 19. 19
  • 20. 20
  • 21. A data frame is used for storing data tables. It is a list of vectors of equal length. §  A data frame is a table, or two-dimensional array-like structure, in which each column contains measurements on one variable, and each row contains one case. As we shall see, a "case" is not necessarily the same as an experimental subject or unit, although they are often the same. 21
  • 22. Combine list of data frames into single data frame, add column with list index: list of vectors of equal length. 22
  • 24. Rna-seq with R Demo: easyRNAseq Source(“c:windowsmynamerna_seq_tutorial.R”) source("/vol/maarten/rna_seq_tutorial2.R") http://bioscholar.com/genomics/bioconductor-packages-analysis-rna-seq-data/
  • 27. Topics: use R console and R command line 27
  • 28. Topics: use R console and R command line 28
  • 29. Topics: use R console and R command line 29
  • 30. Topics: use R console and R command line 30
  • 31. Topics: use R console and R command line 31
  • 32. Topics §  What is R §  What is Bioconductor §  What is RNAseq 32
  • 33.
  • 34. Sequencing by synthesis §  Intro to Sequencing by Synthesis: §  https://www.youtube.com/watch?v=HMyCqWhwB8E 34
  • 35. FASTQ read with 50nt in Illumina format (ASCII_BASE=33). There are always four lines per read. 35
  • 36. 36
  • 37. Paired end: read 1 in one fastq file 37
  • 38. Paired end: read 2 in another fastq file 38
  • 39. Numerous  possible  analysis  strategies   §  There  is  no  one  ‘correct’  way  to   analyze  RNA-­‐seq  data     §  Two  major  branches   •  Direct  alignment  of  reads   (spliced  or  unspliced)  to  genome   or  transcriptome   •  Assembly  of  reads  followed  by   alignment*   *Assembly is the only option when working with a creature with no genome sequence, alignment of contigs may be to ESTs, cDNAs etc or transcriptome Image from Haas & Zody, 2010
  • 40. 40
  • 42. Pile up sequences to reference genome 42
  • 43. SAM format: what are sam/bam files http://biobits.org/samtools_primer.html 43
  • 44. 44
  • 45. RNA  sequencing:  abundance  comparisons   between  two  or  more  condi9ons  /  phenotypes   CondiCon  1   (normal  Cssue)   CondiCon  2   (diseased  Cssue)   Isolate  RNAs   Sequence  ends   100s  of  millions  of  paired  reads   10s  of  billions  bases  of  sequence   Generate  cDNA,  fragment,   size  select,  add  linkers  Samples  of  interest   Map  to  genome,   transcriptome,  and   predicted  exon   junc9ons   Downstream  analysis  
  • 46. Compare two samples for abundance differences 46
  • 48. Genes have ‘structure’, solve by mapping §  This leads to for example analysis of intron-exon structure
  • 51. Common  analysis  goals  of  RNA-­‐Seq    analysis     (what  can  you  ask  of  the  data?)   §  Gene  expression  and  differenCal  expression   §  AlternaCve  expression  analysis   §  Transcript  discovery  and  annotaCon   §  Allele  specific  expression   •  RelaCng  to  SNPs  or  mutaCons   §  MutaCon  discovery   §  Fusion  detecCon   §  RNA  ediCng  
  • 52. Back  to  the  demo   §  IntroducCon  to  RNA  sequencing   §  RaConale  for  RNA  sequencing  (versus  DNA  sequencing)   §  Hands  on  tutorial  
  • 53. Rna-seq with R Demo: easyRNAseq Source(“c:windowsmynamerna_seq_tutorial.R”) source("/vol/maarten/rna_seq_tutorial2.R") http://bioscholar.com/genomics/bioconductor-packages-analysis-rna-seq-data/
  • 54. 54
  • 55. Deseq and DEseq2 §  method based on the negative binomial distribution, with variance and mean linked by local regression §  DEseq2: §  No demo scripts available yet: §  http://www.bioconductor.org/packages/release/bioc/ vignettes/DESeq2/inst/doc/DESeq2.pdf 55
  • 56. The empirical frequency distribution of the hybridization signal intensity values for Affymetrix microarray hybridization data for normal yeast cell genes/ORFs (Jelinsky and Samson 1999). Kuznetsov V A et al. Genetics 2002;161:1321-1332 Copyright © 2002 by the Genetics Society of America
  • 57. Empirical relative frequency distributions of the gene expression levels. Kuznetsov V A et al. Genetics 2002;161:1321-1332 Copyright © 2002 by the Genetics Society of America
  • 58. 58
  • 59. 59
  • 60. Empirical (black dots) and fitted (red lines) dispersion values plotted against the mean of the normalised counts. 60
  • 61. Plot of normalised mean versus log2 fold change for the contrast untreated versus treated. 61
  • 62. Histogram of p-values from the call to nbinomTest. 62
  • 63. MvA plot for the contrast“treated”vs.“untreated”, using two treated and only one untreated sample. 63
  • 64. Heatmaps showing the expression data of the 30 most highly expressed genes 64
  • 65. Heatmap showing the Euclidean distances between the samples as calculated from the variance stabilising transformation of the count data. 65
  • 66. Biological effects of condition and libType 66
  • 67. Mean expression versus log2 fold change plot. Significant hits (at padj<0.1) are coloured in red. 67
  • 68. Per-gene dispersion estimates (shown by points) and the fitted mean- dispersion function (red line). 68
  • 69. Differential exon usage §  Detecting spliced isoform usage by exon-level expression analysis 69
  • 71. expression estimates from a call to testForDEU. Shown in red is the exon that showed significant differential exon usage. 71
  • 72. Normalized counts. As in previous Figure, with normalized count values of each exon in each of the samples. 72
  • 73. estimated effects, but after subtraction of overall changes in gene expression. 73
  • 74. Dependence of dispersion on the mean 74
  • 75. 75
  • 76. Distributions of Fold changes of exon usage 76
  • 77. 77
  • 78. Resources: RNA-Seq workflow, gene-level exploratory analysis and differential expression 78
  • 79. 79
  • 80. Outline   §  IntroducCon  to  RNA  sequencing   §  RaConale  for  RNA  sequencing  (versus  DNA  sequencing)   §  Hands  on  tutorial   §  hQp://swcarpentry.github.io/r-­‐novice-­‐inflammaCon/   §  hQp://swcarpentry.github.io/r-­‐novice-­‐inflammaCon/02-­‐func-­‐R.html   §  hQp://www.bioconductor.org/help/workflows/   §  hQp://www.bioconductor.org/packages/release/data/experiment/ html/parathyroidSE.html   §  hQp://www.bioconductor.org/help/workflows/rnaseqGene/  
  • 81. About bioconductor High-throughput sequence analysis with R and Bioconductor: http://www.bioconductor.org/help/course-materials/2013/useR2013/ Bioconductor-tutorial.pdf http://bioconductor.org/packages/2.13/data/experiment/vignettes/ RnaSeqTutorial/inst/doc/RnaSeqTutorial.pdf Also helpful: http://www.bioconductor.org/help/course-materials/2002/ Summer02Course/Labs/basics.pdf
  • 83.