SlideShare ist ein Scribd-Unternehmen logo
1 von 52
Gene Expression One Cell at a Time
Experimental design and analysis of single-cell RNA-Seq data
David Cook
Vanderhyden Lab, uOttawa
DavidPCook
dpcook
dcook082@uottawa.ca
Conclusions from bulk analysis can be representative of nothing
Bulk analysis
InterpretationSample
Conclusions from bulk analysis can be representative of nothing
Impossible to conclude if differences are due to composition or cancer cells themselves
TCGA, Nature, 2011
Bulk summaries hide underlying structure
X Mean:
Y Mean:
X SD:
Y SD:
Corr:
54.26
47.83
16.76
26.93
-0.06
Matejka and Fitzmaurice (Autodesk Research, Toronto)
Single-cell exposes this heterogeneity
scRNA-Seq
Fur
Venom
Sample Interpretation
Applications of scRNA-Seq
Single-Cell Platforms
Fluidigm C1
Pros
Allows visual inspection of captured
cells
Customizability
Cons
Only two inlets for cell samples
Throughput can’t keep up with field
Relatively long prep time
Live Cell Dead Cell Multiple Live Cells
Calcein AM Ethidium homodimer-1
Droplet-based methods
Pros
Very high throughput
Up to 8 unique samples per run
System cost relatively low
Cons
Limited customizability
Zheng et al., Nature Comm, 2017
Plate methods
Common Chemistry: RT and 3’ Enrichment
Only 3’ end of transcript
is PCR amplified
Why 3’ enrichment?
5’ 3’1kb cDNA
Ten 100bp reads needed for 1x coverage
100bp reads
5’ 3’
200bp 3’ fragment
Two 100bp reads needed for 1x coverage
100bp reads
Consequence: Lose nearly all information about isoform usage (sorry, Matt)
Single-Cell Platforms
10x Genomics
BioRad ddSeq
Fluidigm C1
Plate methods
Cost per cell Cells per run Flexibility/Customizable
+ ~1000-46000 +
++ ~300-10000 +
++++ 96 or 800 +++
Protocol
Dependent
10 - >10k +++++
Cost
10x Genomics
Reagent Kit (20 samples): $20,000
One sample = ~600-6000 cells
Microfluidics Chips (Six 8-sample chips): $1,440
Fluidigm C1 (HT assays)
Reagent Kit (5 runs): $5,000
One run = ~800 cells
Integrated Fluidics Circuit (1 run): $2000
Sequencing
NextSeq500 High Output
1 run ($3700) enough for ~2-3k cells
HiSeq4000
1 lane (~$2700) enough for ~2-3k cells
(Often need to purchase entire flow cell)
Experimental Design
How many cells?
Depends on what you’re looking at
More cells = better detection of rare populations
Mocosko et al,. Cell, 2015
Pollen et al,. Nature Biotech, 2014
More heterogeneity? More cells
Sequencing: How deep do you need to go?
Depends on what you want
Svensson et al., Nature Methods, 2017
Rough Guideline
Aim for 100,000 reads per cell
50,000 per cell is probably fine
Zheng et al., Nature Comm, 2017
16k reads/cell (>60k PBMCs)
Zheng et al., Nature Comm, 2017
Sample numbers and batch effects
Hicks et al., BioRxiv, 2016
Mix biological variables in individual runs!
Sample numbers and batch effects
Tung et al., Scientific Reports, 2017
Analyzing scRNA-Seq Data
Project Background
Control Estrogen
Areas of columnar OSE
Control Estradiol
0
5
10
15
%ovariansurfacethat
hascolumnarcells
*
Areas of hyperplastic OSE
Control Estradiol
5
10
15
%ovariansurface
thatishyperplastic
*
Placebo
E2
E2
Hormone replacement therapy increases risk of ovarian cancer
Exogenous estrogen enhances the cancer progression in mouse models
Prolonged estrogen exposure causes ovarian epithelial dysplasia in
normal mice
General Analysis Workflow
Sequencing
Processing
QC & Filtering
Normalization (and imputation?)
Clustering
Differential expression, trajectory
analysis, network analysis, etc
Alignment, transcript quantification, and import into R
Kallisto – Pseudoalignment to the transcriptome
Bray et al., Nature Biotech, 2016
tximport package to dump gene-level expression matrix into R
Soneson et al., F1000, 2016
General Workflow
Sequencing
Processing
QC & Filtering
Normalization (and imputation?)
Clustering
Differential expression, trajectory
analysis, network analysis, etc
Filtering scRNA-Seq Data
Dead Cell Multiple Live Cells
Ethidium homodimer-1
(Fluidigm specific)
Before Filtering After Filtering
800 cells
30735 genes
636 cells
14300 genes
Filter genes that
are not detected in
at least 10 cells
General Workflow
Sequencing
Processing
QC & Filtering
Normalization (and imputation?)
Clustering
Differential expression, trajectory
analysis, network analysis, etc
Finding and controlling for technical variables
Data exploration is critical
Exprs. matrices
Raw Counts
Log-transformed
Z-scores
Normalized
Cells
Genes
Cell metadataphenoData
Gene metadata
featureData
SCEset:
Finding and controlling for technical variables
1. Library Size
Scaling each library by a size factor
• Counts per million (CPM)
• DESeq
• TMM
• Pooled-based size factors (Lun et al., Genome
Biology, 2016)
Finding and controlling for technical variables
2. Cell Cycle (or other confounding biological processes we aren’t interested in)
Stegle et al., Nature Rev. Genetics, 2015
Cell cycle classification using “scran” package
Cell cycle not driving large amounts of
variation at this point
Finding and controlling for technical variables
3. Other technical variables
Finding variables that drive variation
Coloured by IFC Column
Finding and controlling for technical variables
3. Other technical variables
removeBatchEffect() – limma package
Yi = β0 + β1(TotalFeatures)i + β2(IFC.Row)i + β3(Condition)i + εi
Removes the effect of the technical
covariates on a per-gene basis
Note: IFC.Column tackled same way, but split by condition beforehand
Post-normalization Odd IFC Column
Finding and controlling for technical variables
3. Other technical variables
O_o?
Data Imputation
Data Imputation
Van Dijk et al., BioRxiv, 2017
Data Imputation
Before Imputation After Imputation
Before Imputation
After Imputation
General Workflow
Sequencing
Processing
QC & Filtering
Normalization (and imputation?)
Clustering
Differential expression, trajectory
analysis, network analysis, etc
Clustering
Nature Methods, 2017
General Workflow
Sequencing
Processing
QC & Filtering
Normalization (and imputation?)
Clustering
Differential expression, trajectory
analysis, network analysis, etc
Differential Expression
Currently no “standard”—variety of methods perform pretty well:
• DESeq
• edgeR
• Monocle
• SCDE (single cell differential expression)
Differential Expression
PC2 Values
PC1 Values
PC3 Values
Proteolysis
Actin cytoskeleton organization
Cell adhesion
Innate immune response(?)
Oxidation-reduction process
Oxidative stress
Positive regulation of apoptosis
Metabolic pathways
MAPK signaling
PI3K-Akt signaling
Negative regulation of apoptosis
Cell differentiation
Oxidation-reduction process
Oxidative stress
Proton transport
Mitophagy
Response to wound healing
Response to hypoxia
Apoptosis
Negative regulation of cell cycle
Oxidation-reduction process
Cell adhesion
Rho protein signaling
TCA cycle
Trajectory Analysis
Leveraging asynchrony to reconstruct cellular response trajectories
Wagner et al., Nature Biotech Reviews, 2016
A couple methods:
• Monocle
• Diffusion pseudotime
• PHATE
• Wishbone
• Waterfall
• Wanderlust
• SLICER
• TSCAN
• And more
Trajectory Analysis
Reverse Graph
Embedding
(monocle)
Qiu et al., BioRxiv, 2017
Trajectory Analysis
Can we model the phenotype divergence where estrogen-treated cells progress to form foci?
Does this model foci formation?
Trajectory Analysis
GREB1
Z-projection
Trajectory Analysis
Discovering new transcriptional dynamics
Yi = β0 + β1(Pseudotime)i + β2(Branch)i + β3(Pseudotime)i(Branch)i + εiFull Model:
Yi = β0 + β1(Pseudotime)i + β2(Branch)i + εiReduced Model:
Likelihood Ratio Test to find sig. genes
Trajectory Analysis
Still working on it! But here’s the type of stuff you pull out
Qiu et al., BioRxiv, 2017
Where is the field going?
Trajectory Analysis
• Larger data sets
• Combining the technology with perturbations
• Collecting multiple –omics datasets from individual cells
Dixit et al., Cell, 2016
BioRxiv, 2017
Disclaimer: Much of this will be obsolete in a matter of months
Staying on the ball with scRNA-Seq
Nature Methods, Jan 23rd, 2017
Science, March 3rd, 2017
Nature Methods, March 27th, 2017
Nature Methods, March 6th, 2017
Nature Methods, April 17, 2017
Nature Biotechnology, May 1st, 2017
Resources
Sean Davis’s “Awesome Single Cell” list
https://github.com/seandavi/awesome-single-cell
10x Genomics Public Datasets
https://support.10xgenomics.com/single-cell/datasets
1.3 Million brain cells from E18 mice
68k PBMCs
Fun Tutorials
Seurat: http://satijalab.org/seurat/get_started.html
Monocle (find on Bioconductor)
Thank You!!!

Weitere ähnliche Inhalte

Was ist angesagt?

Whole genome sequencing of bacteria & analysis
Whole genome sequencing of bacteria & analysisWhole genome sequencing of bacteria & analysis
Whole genome sequencing of bacteria & analysisdrelamuruganvet
 
Next generation sequencing
Next generation sequencingNext generation sequencing
Next generation sequencingUzma Jabeen
 
Introduction to Bioinformatics.
 Introduction to Bioinformatics. Introduction to Bioinformatics.
Introduction to Bioinformatics.Elena Sügis
 
DNA Microarray introdution and application
DNA Microarray introdution and applicationDNA Microarray introdution and application
DNA Microarray introdution and applicationNeeraj Sharma
 
Comparison between RNASeq and Microarray for Gene Expression Analysis
Comparison between RNASeq and Microarray for Gene Expression AnalysisComparison between RNASeq and Microarray for Gene Expression Analysis
Comparison between RNASeq and Microarray for Gene Expression AnalysisYaoyu Wang
 
Next Generation Sequencing and its Applications in Medical Research - Frances...
Next Generation Sequencing and its Applications in Medical Research - Frances...Next Generation Sequencing and its Applications in Medical Research - Frances...
Next Generation Sequencing and its Applications in Medical Research - Frances...Sri Ambati
 
Next Generation Sequencing
Next Generation SequencingNext Generation Sequencing
Next Generation SequencingShelomi Karoon
 
Systems biology & Approaches of genomics and proteomics
 Systems biology & Approaches of genomics and proteomics Systems biology & Approaches of genomics and proteomics
Systems biology & Approaches of genomics and proteomicssonam786
 
Single cell RNA sequencing; Methods and applications
Single cell RNA sequencing; Methods and applicationsSingle cell RNA sequencing; Methods and applications
Single cell RNA sequencing; Methods and applicationsfaraharooj
 
Comparative genomics @ sid 2003 format
Comparative genomics @ sid 2003 formatComparative genomics @ sid 2003 format
Comparative genomics @ sid 2003 formatsidjena70
 
Single-Cell Sequencing for Drug Discovery: Applications and Challenges
Single-Cell Sequencing for Drug Discovery: Applications and ChallengesSingle-Cell Sequencing for Drug Discovery: Applications and Challenges
Single-Cell Sequencing for Drug Discovery: Applications and Challengesinside-BigData.com
 
Genomics and Computation in Precision Medicine March 2017
Genomics and Computation in Precision Medicine March 2017Genomics and Computation in Precision Medicine March 2017
Genomics and Computation in Precision Medicine March 2017Warren Kibbe
 
RNA-seq for DE analysis: detecting differential expression - part 5
RNA-seq for DE analysis: detecting differential expression - part 5RNA-seq for DE analysis: detecting differential expression - part 5
RNA-seq for DE analysis: detecting differential expression - part 5BITS
 
Introduction to systems biology
Introduction to systems biologyIntroduction to systems biology
Introduction to systems biologylemberger
 
RNA-seq quality control and pre-processing
RNA-seq quality control and pre-processingRNA-seq quality control and pre-processing
RNA-seq quality control and pre-processingmikaelhuss
 
Metagenomics analysis
Metagenomics  analysisMetagenomics  analysis
Metagenomics analysisVijiMahesh1
 

Was ist angesagt? (20)

Pathway and network analysis
Pathway and network analysisPathway and network analysis
Pathway and network analysis
 
Whole genome sequencing of bacteria & analysis
Whole genome sequencing of bacteria & analysisWhole genome sequencing of bacteria & analysis
Whole genome sequencing of bacteria & analysis
 
Next generation sequencing
Next generation sequencingNext generation sequencing
Next generation sequencing
 
Introduction to Bioinformatics.
 Introduction to Bioinformatics. Introduction to Bioinformatics.
Introduction to Bioinformatics.
 
DNA Microarray introdution and application
DNA Microarray introdution and applicationDNA Microarray introdution and application
DNA Microarray introdution and application
 
Comparison between RNASeq and Microarray for Gene Expression Analysis
Comparison between RNASeq and Microarray for Gene Expression AnalysisComparison between RNASeq and Microarray for Gene Expression Analysis
Comparison between RNASeq and Microarray for Gene Expression Analysis
 
Next Generation Sequencing and its Applications in Medical Research - Frances...
Next Generation Sequencing and its Applications in Medical Research - Frances...Next Generation Sequencing and its Applications in Medical Research - Frances...
Next Generation Sequencing and its Applications in Medical Research - Frances...
 
Next Generation Sequencing
Next Generation SequencingNext Generation Sequencing
Next Generation Sequencing
 
Systems biology & Approaches of genomics and proteomics
 Systems biology & Approaches of genomics and proteomics Systems biology & Approaches of genomics and proteomics
Systems biology & Approaches of genomics and proteomics
 
Data analysis pipelines for NGS applications
Data analysis pipelines for NGS applicationsData analysis pipelines for NGS applications
Data analysis pipelines for NGS applications
 
Single cell RNA sequencing; Methods and applications
Single cell RNA sequencing; Methods and applicationsSingle cell RNA sequencing; Methods and applications
Single cell RNA sequencing; Methods and applications
 
Comparative genomics @ sid 2003 format
Comparative genomics @ sid 2003 formatComparative genomics @ sid 2003 format
Comparative genomics @ sid 2003 format
 
Single-Cell Sequencing for Drug Discovery: Applications and Challenges
Single-Cell Sequencing for Drug Discovery: Applications and ChallengesSingle-Cell Sequencing for Drug Discovery: Applications and Challenges
Single-Cell Sequencing for Drug Discovery: Applications and Challenges
 
Overview of Next Gen Sequencing Data Analysis
Overview of Next Gen Sequencing Data AnalysisOverview of Next Gen Sequencing Data Analysis
Overview of Next Gen Sequencing Data Analysis
 
Whole exome sequencing(wes)
Whole exome sequencing(wes)Whole exome sequencing(wes)
Whole exome sequencing(wes)
 
Genomics and Computation in Precision Medicine March 2017
Genomics and Computation in Precision Medicine March 2017Genomics and Computation in Precision Medicine March 2017
Genomics and Computation in Precision Medicine March 2017
 
RNA-seq for DE analysis: detecting differential expression - part 5
RNA-seq for DE analysis: detecting differential expression - part 5RNA-seq for DE analysis: detecting differential expression - part 5
RNA-seq for DE analysis: detecting differential expression - part 5
 
Introduction to systems biology
Introduction to systems biologyIntroduction to systems biology
Introduction to systems biology
 
RNA-seq quality control and pre-processing
RNA-seq quality control and pre-processingRNA-seq quality control and pre-processing
RNA-seq quality control and pre-processing
 
Metagenomics analysis
Metagenomics  analysisMetagenomics  analysis
Metagenomics analysis
 

Ähnlich wie scRNA-Seq Lecture - Stem Cell Network RNA-Seq Workshop 2017

Fluorescence- Activated Cell Sorter (FACS)
Fluorescence- Activated Cell Sorter (FACS)Fluorescence- Activated Cell Sorter (FACS)
Fluorescence- Activated Cell Sorter (FACS)Nidhi Parikh
 
Applications of Flow Cytometry | Cell Analysis
Applications of Flow Cytometry | Cell AnalysisApplications of Flow Cytometry | Cell Analysis
Applications of Flow Cytometry | Cell AnalysisUniversity of The Punjab
 
Aug2015 analysis team 10 mason epigentics
Aug2015 analysis team 10 mason epigenticsAug2015 analysis team 10 mason epigentics
Aug2015 analysis team 10 mason epigenticsGenomeInABottle
 
Flow Cytometry Training : Introduction day 1 session 1
Flow Cytometry Training : Introduction day 1 session 1Flow Cytometry Training : Introduction day 1 session 1
Flow Cytometry Training : Introduction day 1 session 1Robert (Rob) Salomon
 
Fragment Based Drug Discovery
Fragment Based Drug DiscoveryFragment Based Drug Discovery
Fragment Based Drug DiscoveryAnthony Coyne
 
NAISTビッグデータシンポジウム - バイオ久保先生
NAISTビッグデータシンポジウム - バイオ久保先生NAISTビッグデータシンポジウム - バイオ久保先生
NAISTビッグデータシンポジウム - バイオ久保先生ysuzuki-naist
 
CAMERA Presentation at KNAW ICoMM Colloquium May 2008
CAMERA Presentation at KNAW ICoMM Colloquium May 2008CAMERA Presentation at KNAW ICoMM Colloquium May 2008
CAMERA Presentation at KNAW ICoMM Colloquium May 2008Saul Kravitz
 
Trends In Genomics
Trends In GenomicsTrends In Genomics
Trends In GenomicsSaul Kravitz
 
Interactomics, Integromics to Systems Biology: Next Animal Biotechnology Fron...
Interactomics, Integromics to Systems Biology: Next Animal Biotechnology Fron...Interactomics, Integromics to Systems Biology: Next Animal Biotechnology Fron...
Interactomics, Integromics to Systems Biology: Next Animal Biotechnology Fron...Varij Nayan
 
Advances and Applications Enabled by Single Cell Technology
Advances and Applications Enabled by Single Cell TechnologyAdvances and Applications Enabled by Single Cell Technology
Advances and Applications Enabled by Single Cell TechnologyQIAGEN
 
Paper memo: Optimal-Transport Analysis of Single-Cell Gene Expression Identif...
Paper memo: Optimal-Transport Analysis of Single-Cell Gene Expression Identif...Paper memo: Optimal-Transport Analysis of Single-Cell Gene Expression Identif...
Paper memo: Optimal-Transport Analysis of Single-Cell Gene Expression Identif...Ryohei Suzuki
 
Introduction to biocomputing
 Introduction to biocomputing Introduction to biocomputing
Introduction to biocomputingNatalio Krasnogor
 
Bioinformatics final
Bioinformatics finalBioinformatics final
Bioinformatics finalRainu Rajeev
 
Resolving transcriptional dynamics of the epithelial-mesenchymal transition u...
Resolving transcriptional dynamics of the epithelial-mesenchymal transition u...Resolving transcriptional dynamics of the epithelial-mesenchymal transition u...
Resolving transcriptional dynamics of the epithelial-mesenchymal transition u...David Cook
 

Ähnlich wie scRNA-Seq Lecture - Stem Cell Network RNA-Seq Workshop 2017 (20)

10.1.1.80.2149
10.1.1.80.214910.1.1.80.2149
10.1.1.80.2149
 
Fluorescence- Activated Cell Sorter (FACS)
Fluorescence- Activated Cell Sorter (FACS)Fluorescence- Activated Cell Sorter (FACS)
Fluorescence- Activated Cell Sorter (FACS)
 
2014 naples
2014 naples2014 naples
2014 naples
 
Applications of Flow Cytometry | Cell Analysis
Applications of Flow Cytometry | Cell AnalysisApplications of Flow Cytometry | Cell Analysis
Applications of Flow Cytometry | Cell Analysis
 
Aug2015 analysis team 10 mason epigentics
Aug2015 analysis team 10 mason epigenticsAug2015 analysis team 10 mason epigentics
Aug2015 analysis team 10 mason epigentics
 
Flow Cytometry Training : Introduction day 1 session 1
Flow Cytometry Training : Introduction day 1 session 1Flow Cytometry Training : Introduction day 1 session 1
Flow Cytometry Training : Introduction day 1 session 1
 
BioSB meeting 2015
BioSB meeting 2015BioSB meeting 2015
BioSB meeting 2015
 
Mason abrf single_cell_2017
Mason abrf single_cell_2017Mason abrf single_cell_2017
Mason abrf single_cell_2017
 
Dna microarray mehran- u of toronto
Dna microarray  mehran- u of torontoDna microarray  mehran- u of toronto
Dna microarray mehran- u of toronto
 
2014 villefranche
2014 villefranche2014 villefranche
2014 villefranche
 
Fragment Based Drug Discovery
Fragment Based Drug DiscoveryFragment Based Drug Discovery
Fragment Based Drug Discovery
 
NAISTビッグデータシンポジウム - バイオ久保先生
NAISTビッグデータシンポジウム - バイオ久保先生NAISTビッグデータシンポジウム - バイオ久保先生
NAISTビッグデータシンポジウム - バイオ久保先生
 
CAMERA Presentation at KNAW ICoMM Colloquium May 2008
CAMERA Presentation at KNAW ICoMM Colloquium May 2008CAMERA Presentation at KNAW ICoMM Colloquium May 2008
CAMERA Presentation at KNAW ICoMM Colloquium May 2008
 
Trends In Genomics
Trends In GenomicsTrends In Genomics
Trends In Genomics
 
Interactomics, Integromics to Systems Biology: Next Animal Biotechnology Fron...
Interactomics, Integromics to Systems Biology: Next Animal Biotechnology Fron...Interactomics, Integromics to Systems Biology: Next Animal Biotechnology Fron...
Interactomics, Integromics to Systems Biology: Next Animal Biotechnology Fron...
 
Advances and Applications Enabled by Single Cell Technology
Advances and Applications Enabled by Single Cell TechnologyAdvances and Applications Enabled by Single Cell Technology
Advances and Applications Enabled by Single Cell Technology
 
Paper memo: Optimal-Transport Analysis of Single-Cell Gene Expression Identif...
Paper memo: Optimal-Transport Analysis of Single-Cell Gene Expression Identif...Paper memo: Optimal-Transport Analysis of Single-Cell Gene Expression Identif...
Paper memo: Optimal-Transport Analysis of Single-Cell Gene Expression Identif...
 
Introduction to biocomputing
 Introduction to biocomputing Introduction to biocomputing
Introduction to biocomputing
 
Bioinformatics final
Bioinformatics finalBioinformatics final
Bioinformatics final
 
Resolving transcriptional dynamics of the epithelial-mesenchymal transition u...
Resolving transcriptional dynamics of the epithelial-mesenchymal transition u...Resolving transcriptional dynamics of the epithelial-mesenchymal transition u...
Resolving transcriptional dynamics of the epithelial-mesenchymal transition u...
 

Kürzlich hochgeladen

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
 
DIFFERENCE IN BACK CROSS AND TEST CROSS
DIFFERENCE IN  BACK CROSS AND TEST CROSSDIFFERENCE IN  BACK CROSS AND TEST CROSS
DIFFERENCE IN BACK CROSS AND TEST CROSSLeenakshiTyagi
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxpradhanghanshyam7136
 
Biological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdfBiological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdfmuntazimhurra
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsSumit Kumar yadav
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​kaibalyasahoo82800
 
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...anilsa9823
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsAArockiyaNisha
 
Botany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdfBotany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdfSumit Kumar yadav
 
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
 
Hubble Asteroid Hunter III. Physical properties of newly found asteroids
Hubble Asteroid Hunter III. Physical properties of newly found asteroidsHubble Asteroid Hunter III. Physical properties of newly found asteroids
Hubble Asteroid Hunter III. Physical properties of newly found asteroidsSérgio Sacani
 
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
 
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
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)PraveenaKalaiselvan1
 
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...Sérgio Sacani
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSarthak Sekhar Mondal
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)Areesha Ahmad
 

Kürzlich hochgeladen (20)

The Philosophy of Science
The Philosophy of ScienceThe Philosophy of Science
The Philosophy of Science
 
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
 
DIFFERENCE IN BACK CROSS AND TEST CROSS
DIFFERENCE IN  BACK CROSS AND TEST CROSSDIFFERENCE IN  BACK CROSS AND TEST CROSS
DIFFERENCE IN BACK CROSS AND TEST CROSS
 
Cultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptxCultivation of KODO MILLET . made by Ghanshyam pptx
Cultivation of KODO MILLET . made by Ghanshyam pptx
 
Biological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdfBiological Classification BioHack (3).pdf
Biological Classification BioHack (3).pdf
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questions
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​
 
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
Lucknow 💋 Russian Call Girls Lucknow Finest Escorts Service 8923113531 Availa...
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based Nanomaterials
 
Botany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdfBotany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdf
 
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...
 
Hubble Asteroid Hunter III. Physical properties of newly found asteroids
Hubble Asteroid Hunter III. Physical properties of newly found asteroidsHubble Asteroid Hunter III. Physical properties of newly found asteroids
Hubble Asteroid Hunter III. Physical properties of newly found asteroids
 
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
 
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
 
9953056974 Young Call Girls In Mahavir enclave Indian Quality Escort service
9953056974 Young Call Girls In Mahavir enclave Indian Quality Escort service9953056974 Young Call Girls In Mahavir enclave Indian Quality Escort service
9953056974 Young Call Girls In Mahavir enclave Indian Quality Escort service
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)
 
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
PossibleEoarcheanRecordsoftheGeomagneticFieldPreservedintheIsuaSupracrustalBe...
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
 
Engler and Prantl system of classification in plant taxonomy
Engler and Prantl system of classification in plant taxonomyEngler and Prantl system of classification in plant taxonomy
Engler and Prantl system of classification in plant taxonomy
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)
 

scRNA-Seq Lecture - Stem Cell Network RNA-Seq Workshop 2017

  • 1. Gene Expression One Cell at a Time Experimental design and analysis of single-cell RNA-Seq data David Cook Vanderhyden Lab, uOttawa DavidPCook dpcook dcook082@uottawa.ca
  • 2. Conclusions from bulk analysis can be representative of nothing Bulk analysis InterpretationSample
  • 3. Conclusions from bulk analysis can be representative of nothing Impossible to conclude if differences are due to composition or cancer cells themselves TCGA, Nature, 2011
  • 4. Bulk summaries hide underlying structure X Mean: Y Mean: X SD: Y SD: Corr: 54.26 47.83 16.76 26.93 -0.06 Matejka and Fitzmaurice (Autodesk Research, Toronto)
  • 5. Single-cell exposes this heterogeneity scRNA-Seq Fur Venom Sample Interpretation
  • 8. Fluidigm C1 Pros Allows visual inspection of captured cells Customizability Cons Only two inlets for cell samples Throughput can’t keep up with field Relatively long prep time Live Cell Dead Cell Multiple Live Cells Calcein AM Ethidium homodimer-1
  • 9. Droplet-based methods Pros Very high throughput Up to 8 unique samples per run System cost relatively low Cons Limited customizability Zheng et al., Nature Comm, 2017
  • 11. Common Chemistry: RT and 3’ Enrichment Only 3’ end of transcript is PCR amplified
  • 12. Why 3’ enrichment? 5’ 3’1kb cDNA Ten 100bp reads needed for 1x coverage 100bp reads 5’ 3’ 200bp 3’ fragment Two 100bp reads needed for 1x coverage 100bp reads Consequence: Lose nearly all information about isoform usage (sorry, Matt)
  • 13. Single-Cell Platforms 10x Genomics BioRad ddSeq Fluidigm C1 Plate methods Cost per cell Cells per run Flexibility/Customizable + ~1000-46000 + ++ ~300-10000 + ++++ 96 or 800 +++ Protocol Dependent 10 - >10k +++++
  • 14. Cost 10x Genomics Reagent Kit (20 samples): $20,000 One sample = ~600-6000 cells Microfluidics Chips (Six 8-sample chips): $1,440 Fluidigm C1 (HT assays) Reagent Kit (5 runs): $5,000 One run = ~800 cells Integrated Fluidics Circuit (1 run): $2000 Sequencing NextSeq500 High Output 1 run ($3700) enough for ~2-3k cells HiSeq4000 1 lane (~$2700) enough for ~2-3k cells (Often need to purchase entire flow cell)
  • 16. How many cells? Depends on what you’re looking at More cells = better detection of rare populations Mocosko et al,. Cell, 2015 Pollen et al,. Nature Biotech, 2014 More heterogeneity? More cells
  • 17. Sequencing: How deep do you need to go? Depends on what you want Svensson et al., Nature Methods, 2017 Rough Guideline Aim for 100,000 reads per cell 50,000 per cell is probably fine Zheng et al., Nature Comm, 2017 16k reads/cell (>60k PBMCs) Zheng et al., Nature Comm, 2017
  • 18. Sample numbers and batch effects Hicks et al., BioRxiv, 2016 Mix biological variables in individual runs!
  • 19. Sample numbers and batch effects Tung et al., Scientific Reports, 2017
  • 21. Project Background Control Estrogen Areas of columnar OSE Control Estradiol 0 5 10 15 %ovariansurfacethat hascolumnarcells * Areas of hyperplastic OSE Control Estradiol 5 10 15 %ovariansurface thatishyperplastic * Placebo E2 E2 Hormone replacement therapy increases risk of ovarian cancer Exogenous estrogen enhances the cancer progression in mouse models Prolonged estrogen exposure causes ovarian epithelial dysplasia in normal mice
  • 22. General Analysis Workflow Sequencing Processing QC & Filtering Normalization (and imputation?) Clustering Differential expression, trajectory analysis, network analysis, etc
  • 23. Alignment, transcript quantification, and import into R Kallisto – Pseudoalignment to the transcriptome Bray et al., Nature Biotech, 2016 tximport package to dump gene-level expression matrix into R Soneson et al., F1000, 2016
  • 24. General Workflow Sequencing Processing QC & Filtering Normalization (and imputation?) Clustering Differential expression, trajectory analysis, network analysis, etc
  • 25. Filtering scRNA-Seq Data Dead Cell Multiple Live Cells Ethidium homodimer-1 (Fluidigm specific) Before Filtering After Filtering 800 cells 30735 genes 636 cells 14300 genes Filter genes that are not detected in at least 10 cells
  • 26. General Workflow Sequencing Processing QC & Filtering Normalization (and imputation?) Clustering Differential expression, trajectory analysis, network analysis, etc
  • 27. Finding and controlling for technical variables Data exploration is critical Exprs. matrices Raw Counts Log-transformed Z-scores Normalized Cells Genes Cell metadataphenoData Gene metadata featureData SCEset:
  • 28. Finding and controlling for technical variables 1. Library Size Scaling each library by a size factor • Counts per million (CPM) • DESeq • TMM • Pooled-based size factors (Lun et al., Genome Biology, 2016)
  • 29. Finding and controlling for technical variables 2. Cell Cycle (or other confounding biological processes we aren’t interested in) Stegle et al., Nature Rev. Genetics, 2015 Cell cycle classification using “scran” package Cell cycle not driving large amounts of variation at this point
  • 30. Finding and controlling for technical variables 3. Other technical variables Finding variables that drive variation Coloured by IFC Column
  • 31. Finding and controlling for technical variables 3. Other technical variables removeBatchEffect() – limma package Yi = β0 + β1(TotalFeatures)i + β2(IFC.Row)i + β3(Condition)i + εi Removes the effect of the technical covariates on a per-gene basis Note: IFC.Column tackled same way, but split by condition beforehand Post-normalization Odd IFC Column
  • 32. Finding and controlling for technical variables 3. Other technical variables O_o?
  • 34. Data Imputation Van Dijk et al., BioRxiv, 2017
  • 35. Data Imputation Before Imputation After Imputation Before Imputation After Imputation
  • 36. General Workflow Sequencing Processing QC & Filtering Normalization (and imputation?) Clustering Differential expression, trajectory analysis, network analysis, etc
  • 38. General Workflow Sequencing Processing QC & Filtering Normalization (and imputation?) Clustering Differential expression, trajectory analysis, network analysis, etc
  • 39. Differential Expression Currently no “standard”—variety of methods perform pretty well: • DESeq • edgeR • Monocle • SCDE (single cell differential expression)
  • 40. Differential Expression PC2 Values PC1 Values PC3 Values Proteolysis Actin cytoskeleton organization Cell adhesion Innate immune response(?) Oxidation-reduction process Oxidative stress Positive regulation of apoptosis Metabolic pathways MAPK signaling PI3K-Akt signaling Negative regulation of apoptosis Cell differentiation Oxidation-reduction process Oxidative stress Proton transport Mitophagy Response to wound healing Response to hypoxia Apoptosis Negative regulation of cell cycle Oxidation-reduction process Cell adhesion Rho protein signaling TCA cycle
  • 41. Trajectory Analysis Leveraging asynchrony to reconstruct cellular response trajectories Wagner et al., Nature Biotech Reviews, 2016 A couple methods: • Monocle • Diffusion pseudotime • PHATE • Wishbone • Waterfall • Wanderlust • SLICER • TSCAN • And more
  • 43. Trajectory Analysis Can we model the phenotype divergence where estrogen-treated cells progress to form foci? Does this model foci formation?
  • 45. Trajectory Analysis Discovering new transcriptional dynamics Yi = β0 + β1(Pseudotime)i + β2(Branch)i + β3(Pseudotime)i(Branch)i + εiFull Model: Yi = β0 + β1(Pseudotime)i + β2(Branch)i + εiReduced Model: Likelihood Ratio Test to find sig. genes
  • 46. Trajectory Analysis Still working on it! But here’s the type of stuff you pull out Qiu et al., BioRxiv, 2017
  • 47. Where is the field going?
  • 48. Trajectory Analysis • Larger data sets • Combining the technology with perturbations • Collecting multiple –omics datasets from individual cells Dixit et al., Cell, 2016 BioRxiv, 2017
  • 49. Disclaimer: Much of this will be obsolete in a matter of months
  • 50. Staying on the ball with scRNA-Seq Nature Methods, Jan 23rd, 2017 Science, March 3rd, 2017 Nature Methods, March 27th, 2017 Nature Methods, March 6th, 2017 Nature Methods, April 17, 2017 Nature Biotechnology, May 1st, 2017
  • 51. Resources Sean Davis’s “Awesome Single Cell” list https://github.com/seandavi/awesome-single-cell 10x Genomics Public Datasets https://support.10xgenomics.com/single-cell/datasets 1.3 Million brain cells from E18 mice 68k PBMCs Fun Tutorials Seurat: http://satijalab.org/seurat/get_started.html Monocle (find on Bioconductor)

Hinweis der Redaktion

  1. CPM not robust to high amounts of differential expression DESeq and TMM don’t hold up well to lots of zero counts