SlideShare uma empresa Scribd logo
1 de 128
Introduction to Single-cell RNA-Seq
Wally the Welsh Corgi
Connecting & Computer Preliminaries
Make sure your workshop provided computer is connected to the
“Broad” or “Broad Internal” wireless network.
Please do not connect your personal items
(laptop, phone, etc.) to these wireless networks; it will tax the
wireless system and make the workshop less effective.
The password for computers is “password”.
Introduction to single-cell RNA-Seq
Timothy Tickle
Brian Haas
Asma Bankapur
Center for Cell Circuits Computational Genomics Workshop 2017
We Know Tissues are Heterogeneous
Cell Identity is More Than Histopathology
A cell participates in
multiple cell contexts.
Multiple factors shape a cell’s identity
- Membership in a taxonomy
of cell types
- Simultaneous time-
dependent processes
- Response to the
environment
- Spatial positioning
Before We Get Started
• Single-cell RNA-Seq (scRNA-Seq) analysis methodology is developing.
– Give you a feel for the data.
– Perform some analysis together.
• There is a vivid diversity of methodology.
– These technique will grow as the field does.
– Why were these specific tools chosen?
• This is a guided conversation through scRNA-Seq analysis.
– Breadth and targeted depth.
– There may be other opinions, if you have one, please speak up so
we can all learn from it.
• Sections will be hands-on.
– Much can be applied to other
analysis.
– Strengthen those R ninja skills!
– If you need, cut and pasting is
available.
• cut_and_paste.txt
• There will be many cute
corgi pictures.
Before We Get Started
We Will Attempt to Cover
• Describe scRNA-Seq assays.
• Comparing assays.
• Sequence pipelines.
• How do measured counts behave?
• Concerns over study design.
• Initial data exploration.
• Gene and cell filtering.
• Plotting genes.
• Dimensional Reduction and plotting cells.
• Differential expression.
• Communicating your study.
Section: scRNA-Seq Assays
• There are many scRNA-Seq Assays, each differs:
– Some commercialized
– Full transcriptome vs 3’
– Less or more automated
– Different levels of throughput
– Differences in cost
Smart-Seq2
• Developed for single cell but can performed using total RNA.
• Selects for poly-A tail.
• Full transcript assay.
– Uses template switching for 5' end capture.
• Standard illumina sequencing.
– Off-the-shelf products.
• Hundreds of samples.
• Often do not see UMI used.
Smart-Seq2: Description
Full transcript scRNA-Seq
• Poly-A capture with 30nt polyT and
25nt 5' anchor sequence.
• RT adding untemplated C
• Template switching
• Locked Nucleic Acid binds to
untemplated C
• RT switches template
• Preamplification / cleanup
• DNA fragmentation and adapter
ligation together.
• Gap Repair, enrich, purify.
Smart-Seq2: Assay Overview
Smart-Seq2: Equipment
Drop-seq
Drop-seq: Description
• Moved throughput from hundreds to thousands.
• Droplet-based processing using microfluidics
• Nanoliter scale aqueous drops in oil.
• 3' End
• Bead based (STAMPs).
• Single-cell transcriptomes attached to microparticles.
• Cell barcodes use split-pool synthesis.
• Uses UMI (Unique Molecular Identifier).
• RMT (Random Molecular Tag).
• Degenerate synthesis.
Drop-seq: Overview
• Click Here for Drop-seq Video Abstract
Drop-seq: Assay Overview
Drop-seq: Assay Overview
Drop-seq: Assay Overview
Drop-seq: Equipment
Drop-seq: Pointers
• Droplet-based assays can have leaky RNA.
• Before library generation wash off any medium (inhibits library
generation).
• Adding PBS and BSA (0.05-0.01%) can protect the cell.
– Too much produces a residue making harvesting the beads difficult.
• Filter all reagent with a 80 micron strainer before microfluidics.
• Some purchased devices add a hydrophobic coating.
– Can deteriorate (2 months at best).
– Recoating does work (in-house).
10X: Massively Parallel Sequencing
10X: Description
• Droplet-based, 3' mRNA.
– GEM (Gel Bead in Emulsion)
• Standardized instrumentation and reagents.
• More high-throughput scaling to tens of thousands.
• Less processing time.
• Cell Ranger software is available for install.
10X: Assay Overview
10X: Assay Overview
10X: Equipment
A Word on Sorting
• After disassociating cells cells can be performed.
• Know your cells, are they sticky, are they big?
– Select an appropriate sized nozzle.
• Don't sort too quickly (1-2k cells per second or lower)
– The slower the more time cells sit in lysis after sorting
– 10 minutes max in lysis (some say 30 minutes)
• Calibrate speed of instrument with beads
– Check alignment every 5-6 plates
• Afterwards spin down to make sure cells are in lysis buffer
– Flash freeze
• Chloe Villani on sorting [click here]
Section: Comparing scRNA-Seq Assays
scRNA-Seq Assay Performance
ERCC-based Benchmarking
• Based on ERCC spike-ins.
– Exogenous RNA-Spikins
– No secondary structure
– 25b polyA Tail
• May be a conservative measurement given endogenous mRNA will
have ~250b polyA.
• Accuracy
– How well the abundance levels correlated with known spiked-in
amounts.
• Sensitivity
– Minimum number of input RNA molecules required to detect a spike-in.
Sensitivity and Specificity
Accuracy
Great!
Poor
Sensitivity
Bulk
Great!
Bulk CEL-Seq2
Drop-Seq
10XSmart-Seq2
10 molecules
1 molecule
Final Thoughts
• Different assays have different throughput.
– SmartSeq2 < Drop-seq < 10X
• SmartSeq2 is full transcript.
• Plate-based methods get lysed in wells and so do not leak.
– Droplet-based can have leaky RNA.
• In Drop-seq assays RT happens outside the droplets
– Can use harsher lysis buffers.
– 10X needs lysis buffers compatible with the RT enzyme.
• 10X is more standardized and comes with a pipeline.
– Drop-seq is more customizable but more hands-on.
• Cost per library varies greatly.
Section: scRNA-Seq Pipelines
Sequences Differ So Pipelines Differ
• scRNA-Seq assays are different and produce different
sequences
– The sequence pipelines must be tailored to the sequence of
interest.
– Many pipelines are NOT compatible but many show
similarities.
Start with FASTQ Sequences
FASTQ File Format
Sequence Header
cDNA Sequence
Base Quality
4 Lines are 1
sequence
Assays Differ in FASTQ Contents
SmartSeq2: Pipeline Overview
• Common functionality:
trimming, alignment,
generating count matrix.
• Adds book keeping for cell
barcodes and UMIs, bead
error detection, cell barcode
collapsing, UMI collapsing.
Drop-seq: Pipeline Overview
Drop-seq: Further Help
• Steps conceptually similar to
the Drop-seq pipeline.
10X: Pipeline Overview
10X: Further Help
• Much of the QC that is
performed is using traditional
tools.
Sequence Level Quality Control
Pipeline Section Summary
• Single-cell RNA-Seq is a diverse ecosystem of assays.
– Each assay has pros and cons.
• Sequences derived from these assays are complex and vary.
• Different pipelines are needed to address different sequence
formats.
– Common steps include:
• Aligning
• QC
• Read counting.
Section: scRNA-Seq Count Data
This is an Expression Matrix
Genes Have Different Distributions
Genes Have Different Distributions
Genes Have Different Distributions
Genes Have Different Distributions
Genes Have Different Distributions
• Zero inflation.
– Drop-out event during reverse-
transcription.
– Genes with more expression
have less zeros.
– Complexity varies.
• Transcription stochasticity.
– Transcription bursting.
– Coordinated transcription of
multigene networks.
– Over-dispersed counts.
• Higher Resolution.
– More sources of signal
Underlying Biology
Expression has Many Sources per Cell
Data Analysis with UMIs
Read Counts Counts by UMI
Collapsed but Not Linear
Summary of the Data
• We are still understanding scData and how to apply it.
– Data can be NOT normal.
– Data can be Zero-inflated.
– Data can be very noisy.
– Cells vary in library complexity.
– Can represent many “basis vectors” or sources of expression
simultaneously.
• Keeping these characteristics in analysis assumptions.
• Tend to filter more conservatively with UMIs.
Section: Study Design and scRNA-Seq
scRNA-Seq Study Design
• How many cells?
– Can change depending on the variability of the biology and
the expectation of finding rare populations.
• How to design cell capture?
– Single cell RNA-Seq is especially prone to technical batch
affects (due to processing).
• Use of UMIs
• Use of ERCC spike-ins
How Many Cells?
• Satija lab online tool
– satijalab.org/howmanycells
Single Cell RNA-Seq and Batch Affects
What is Study Confounding?
Confounding by Design
Section: Initial Data Analysis
Motivation: Why Am I Using R?
• A lot of method development is happening in R.
• Free / open source / open science.
• Many supplemental computational biology packages.
• Data science is an art.
– Data often requires one to create and manipulate
analysis.
• This will allow you to experience key concepts in analysis.
RStudio (IDE)
Initial Data Exploration
Today’s Data
• To generate a comprehensive,
validated classification scheme
for the bipolar cells of the
mouse retina.
– Cone or rod type, ON or OFF, 9-12 subtypes (morphological)
• ~44k cells from a transgenic mouse line marking BCs
– After filtering 27k (we use 5k)
Logistics: Importing Code Libraries
• R Exercise
Representing Sparse Matrices
• R Exercise
What is a Sparse Matrix?
• Sparse Matrix
– A matrix where most of the elements are 0.
• Dense Matrix
– A matrix where most elements are not 0.
• Many ways to efficiently represent a sparse matrix in memory.
– Here, the underlying data structure is a coordinate list.
2D Arrays vs Coordinate Lists
Can be optimal for dense matrices More optimal for sparse matrices
VS
Seurat
https://github.com/satijalab/seurat
Create a Seurat Object
• R exercise
Expression: Bulk RNA-Seq Definition
In bulk RNA-Seq we learned counts are not expression.
• Some counts belong to sequences which could go to many genes.
• Some transcripts are longer than other so they get sequenced more.
• Some samples are more deeply sequenced.
• The data is not normally distributed.
Depending on the scRNA-Seq assay these may be important.
Seurat has assumptions it makes with it’s defaults
– More appropriate for 3 prime assays.
Count Preparation is Different
Depending on the Source
RSEM
KALLISTO
TPM
RSEM
KALLISTO
Correct for Sequencing Depth
Log2() + 1Log2() + 1
Correct for Sequencing Depth
X / Column Total * 1E5 or 1E6
TPMSeurat
Seurat Seurat
No transcript length correction
Prepping Counts For Seurat
3 prime-
• Expected by Seurat.
• Counts collapsed with UMIs.
• Log2 transform (in Seurat).
• Account for sequencing depth (in Seurat).
Full Transcript Sequencing-
• Can be used in Seurat.
• TPM +1 transformed counts.
• Log2 transform (in Seurat).
• Sequencing depth is already accounted.
Sometimes Averages are Not Useful
Say you were standing with one foot in the oven and one foot in
an ice bucket. According to the percentage people, you should
be perfectly comfortable. –Bobby Bragan
Filtering Genes: Averages are Less Useful
Filtering Genes: Using Prevalence
Filtering Genes: Using Prevalence
Filtering Using Metadata
What is Metadata?
Other information that describes your measurements.
– Patient information.
• Life style (smoking), Patient Biology (age), Comorbidity
– Study information.
• Treatment, Cage, Sequencing Site, Sequencing Date
– Sequence QC on cells.
• Useful in filtering.
Filtering Cells: Removing Outlier Cells
• Bulk RNA-Seq studies often do not remove outliers cells
– scRNA-Seq often removes “failed libraries”.
• Outlier cells are not just measured by complexity
• Percent Reads Mapping
• Percent Mitochondrial Reads
• Presence of marker genes
• Intergenic/ exonic rate
• 5' or 3' bias
• other metadata …
• Useful Tools
– Picard Tools and RNASeQC
Seurat: Filtering on Metadata
• R Exercise
Section: Plot Genes
Seurat: Viewing Specific Genes
• R Exercise
Section: Working with Batch Affects
Normalization and Batch Affect Correction
• The nature of scRNA-Seq assays can make them prone to
confounding with batch affects.
– Normalization and batch affect correction can help.
• Some are moving away from relying on a specific method.
– Exploring the idea of combining or selecting from a
collection of normalization or correction methods best for a
specific study.
• Some believe UMI based analysis need not be normalized
between samples given the absolute count of the molecules
are being reported.
– Be careful not to remove biological signal with good
experimental design (avoiding confounding by design).
Seurat and Batch Affect Correction
• Using linear models one can regress covariates.
– scale.data hold the residuals after regressing (z-scored)
• Dimensionality reduction and clustering.
• We use metadata we have.
– One could imagine creating a metadata for cell cycle.
Seurat and Batch Affect Correction
• R exercise
Section: Dimensionality Reduction and
Plotting Samples
Dimensionality Reduction
• Start with many measurements (high dimensional).
– Want to reduce to few features (lower-dimensional space).
• One way is to extract features based on capturing groups of
variance.
• Another could be to preferentially select some of the current
features.
– We have already done this.
• We need this to plot the cells in 2D (or ordinate them)
• In scRNA-Seq PC1 may be complexity.
• Eigenvectors of covariance
matrix.
• Find orthogonal groups of
variance.
• Given from most to least
variance.
– Components of variation.
– Linear combinations explaining
the variance.
PCA: in Quick Theory
PCA: an Interactive Example
• PCA Explained Visually
PCA: in Practice
Things to be aware of-
• Data with different magnitudes will dominate.
– Zero center and divided by SD.
• (Standardized).
• Can be affected by outliers.
• Data is often first filtered to remove noise.
t-SNE: Nonlinear Dimensional
Reduction
t-SNE: Collapsing the Visualization to 2D
t-SNE: How it works.
PCA and t-SNE Together
• Often t-SNE is performed on PCA components
– Liberal number of components.
– Removes mild signal (assumption of noise).
– Faster, on less data but, hopefully the same signal.
Learn More About t-SNE
• Awesome Blog on t-SNE parameterization
– http://distill.pub/2016/misread-tsne
• Publication
– https://lvdmaaten.github.io/publications/papers/JMLR_200
8.pdf
• Nice YouTube Video
– https://www.youtube.com/watch?v=RJVL80Gg3lA
• Code
– https://lvdmaaten.github.io/tsne/
• Interactive Tensor flow
– http://projector.tensorflow.org/
Plotting Cells
Plotting Cells and Gene Expression
• R exercise.
• Smart Local Moving (SLM) algorithm for community (cluster)
detection in large networks.
– Can be applied to 10s of millions cells, 100s of millions of relationships.
– Evolved from the Louvain algorithm
Defining Clusters through Graphs
http://www.ludowaltman.nl/slm/
Local Moving Heuristic
1 2
3 4
5
6
7
Section Summary
• Dimensionality reduction help reduce data while hopefully
keeping important signal.
– t-SNE on PCA is often used in analysis
• Created several types of plot often seen in publications.
– Plotting genes (through subgroups).
– Ordinating cells in t-SNE space.
– Heat maps of genes associated with PC components.
– Plotting metadata on projects of data is an important QC
tool.
• Cluster of cells are currently defined through graph, separate
from the ordination (t-SNE / PCA).
Section: Differential Expression
Seurat: Differential Expression
• Default if one cluster again many tests.
– Can specify an ident.2 test between clusters.
• Adding speed by exluding tests.
– Min.pct - controls for sparsity
– Min percentage in a group
– Thresh.test - must have this difference in averages.
Seurat: Many Choices for DE
• bimod
– Tests differences in mean and proportions.
• roc
– Uses AUC like definition of separation.
• t
– Student's T-test.
• tobit
– Tobit regression on a smoothed data.
Seurat: DE and Plotting DE Genes
• R Exercise.
Dot plots
Size of circle
• Gene prevalence in cluster.
Color of circle
• More red, more expressed in cluster.
Scales well with many cells.
sparse genesprevalent genes
lowly
expressed
highly
expressed
very
specific
• Additionally introduces a
GSEA method.
Mast
• Uses hurdle model
– Two part generalized linear
model to address both rate of
expression (prevalence) and
expression.
– GLM means covariates can be
used to control for unwanted
signal.
• CDR: Cellular detection rate
– Cellular complexity
– Values below a threshold are 0
https://github.com/RGLab/MAST
Mast: Hurdle Models
Logistic Regression Gaussian Linear Model
Mast: DE and Plotting DE Genes
• R Exercise.
Section: Communicating Results to Collaborators
• Designing a study.
• Writing a grant.
• Performing experiments.
• Collecting data.
• Running sequencing pipelines.
• Performing some preliminary analysis.
• Sharing ideas with private collaborators.
• Refining analysis.
• Completing a paper.
• Sharing analysis publicly.
The Single Cell Portal
https://portals.broadinstitute.org/single_cell
The Single Cell Portal
Study Descriptions Can Be Created
The Single Cell Portal
Data Can Be Shared
The Single Cell Portal
One Can Interact with Cell Clusters
The Single Cell Portal
Gene Expression Can be Viewed Across Clusters
The Single Cell Portal
Gene Expression Can be Viewed Across Clusters
The Single Cell Portal
Multiple Clustering Can be Used
The Single Cell Portal
Genes Can Be Viewed in Many Clusters
The Single Cell Portal
Expression Can Be Shown in Many Clusterings
The Single Cell Portal
Expression in Clusters Can Also Be Shown as Heatmaps
The Single Cell Portal
• Studies can be …
– Private
– Private but shared privately
– Public but with data inaccessible
– Public
Section: Wrapping Up
What Did We Miss (So Much)?
So much more to learn!
We covered this
Awesome List
https://github.com/seandavi/awesome-single-cell
Single Cell Network
www.singlecellnetwork.org
Thank You
Aviv Regev
Brian Haas
Adam Haber
Anindita Basu
Asma Bankapur
Chloe Villani
Karthik Shekhar
Kristine Schwenck
Matan Hofree
Michel Cole
Monika Kowalczyk
Nir Yosef
Sean Simmons
Regev Single Cell Working Group
Today's Attendees
Questions?

Mais conteúdo relacionado

Mais procurados

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
 
Creating a SNP calling pipeline
Creating a SNP calling pipelineCreating a SNP calling pipeline
Creating a SNP calling pipelineDan Bolser
 
Single-cell RNA-seq tutorial
Single-cell RNA-seq tutorialSingle-cell RNA-seq tutorial
Single-cell RNA-seq tutorialAaron Diaz
 
RNA-seq Data Analysis Overview
RNA-seq Data Analysis OverviewRNA-seq Data Analysis Overview
RNA-seq Data Analysis OverviewSean Davis
 
Exome seuencing (steps, method, and applications)
Exome seuencing (steps, method, and applications)Exome seuencing (steps, method, and applications)
Exome seuencing (steps, method, and applications)Hamza Khan
 
RNA Sequencing from Single Cell
RNA Sequencing from Single CellRNA Sequencing from Single Cell
RNA Sequencing from Single CellQIAGEN
 
Prokka - rapid bacterial genome annotation - ABPHM 2013
Prokka - rapid bacterial genome annotation - ABPHM 2013Prokka - rapid bacterial genome annotation - ABPHM 2013
Prokka - rapid bacterial genome annotation - ABPHM 2013Torsten Seemann
 
Processing Raw scRNA-Seq Sequencing Data
Processing Raw scRNA-Seq Sequencing DataProcessing Raw scRNA-Seq Sequencing Data
Processing Raw scRNA-Seq Sequencing DataAlireza Doustmohammadi
 
Next Gen Sequencing (NGS) Technology Overview
Next Gen Sequencing (NGS) Technology OverviewNext Gen Sequencing (NGS) Technology Overview
Next Gen Sequencing (NGS) Technology OverviewDominic Suciu
 
Next Generation Sequencing
Next Generation SequencingNext Generation Sequencing
Next Generation SequencingShelomi Karoon
 
Next generation sequencing technologies for crop improvement
Next generation sequencing technologies for crop improvementNext generation sequencing technologies for crop improvement
Next generation sequencing technologies for crop improvementanjaligoud
 
2016. daisuke tsugama. next generation sequencing (ngs) for plant research
2016. daisuke tsugama. next generation sequencing (ngs) for plant research2016. daisuke tsugama. next generation sequencing (ngs) for plant research
2016. daisuke tsugama. next generation sequencing (ngs) for plant researchFOODCROPS
 
Next generation sequencing
Next  generation  sequencingNext  generation  sequencing
Next generation sequencingNidhi Singh
 
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
 

Mais procurados (20)

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
 
RNA-Seq
RNA-SeqRNA-Seq
RNA-Seq
 
Creating a SNP calling pipeline
Creating a SNP calling pipelineCreating a SNP calling pipeline
Creating a SNP calling pipeline
 
Single-cell RNA-seq tutorial
Single-cell RNA-seq tutorialSingle-cell RNA-seq tutorial
Single-cell RNA-seq tutorial
 
RNA-seq Data Analysis Overview
RNA-seq Data Analysis OverviewRNA-seq Data Analysis Overview
RNA-seq Data Analysis Overview
 
Exome seuencing (steps, method, and applications)
Exome seuencing (steps, method, and applications)Exome seuencing (steps, method, and applications)
Exome seuencing (steps, method, and applications)
 
RNA Sequencing from Single Cell
RNA Sequencing from Single CellRNA Sequencing from Single Cell
RNA Sequencing from Single Cell
 
Clinical Applications of Next Generation Sequencing
Clinical Applications of Next Generation SequencingClinical Applications of Next Generation Sequencing
Clinical Applications of Next Generation Sequencing
 
Prokka - rapid bacterial genome annotation - ABPHM 2013
Prokka - rapid bacterial genome annotation - ABPHM 2013Prokka - rapid bacterial genome annotation - ABPHM 2013
Prokka - rapid bacterial genome annotation - ABPHM 2013
 
Ngs ppt
Ngs pptNgs ppt
Ngs ppt
 
NGS: Mapping and de novo assembly
NGS: Mapping and de novo assemblyNGS: Mapping and de novo assembly
NGS: Mapping and de novo assembly
 
Processing Raw scRNA-Seq Sequencing Data
Processing Raw scRNA-Seq Sequencing DataProcessing Raw scRNA-Seq Sequencing Data
Processing Raw scRNA-Seq Sequencing Data
 
Next Gen Sequencing (NGS) Technology Overview
Next Gen Sequencing (NGS) Technology OverviewNext Gen Sequencing (NGS) Technology Overview
Next Gen Sequencing (NGS) Technology Overview
 
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
 
Next Generation Sequencing
Next Generation SequencingNext Generation Sequencing
Next Generation Sequencing
 
Next generation sequencing technologies for crop improvement
Next generation sequencing technologies for crop improvementNext generation sequencing technologies for crop improvement
Next generation sequencing technologies for crop improvement
 
2016. daisuke tsugama. next generation sequencing (ngs) for plant research
2016. daisuke tsugama. next generation sequencing (ngs) for plant research2016. daisuke tsugama. next generation sequencing (ngs) for plant research
2016. daisuke tsugama. next generation sequencing (ngs) for plant research
 
Next generation sequencing
Next  generation  sequencingNext  generation  sequencing
Next generation sequencing
 
Exome Sequencing
Exome SequencingExome Sequencing
Exome Sequencing
 
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
 

Destaque

single-cell-sequencing-research-review
single-cell-sequencing-research-reviewsingle-cell-sequencing-research-review
single-cell-sequencing-research-reviewSwati Kadam Ph.D.
 
Analysis of Single-Cell Sequencing Data by CLC/Ingenuity: Single Cell Analysi...
Analysis of Single-Cell Sequencing Data by CLC/Ingenuity: Single Cell Analysi...Analysis of Single-Cell Sequencing Data by CLC/Ingenuity: Single Cell Analysi...
Analysis of Single-Cell Sequencing Data by CLC/Ingenuity: Single Cell Analysi...QIAGEN
 
RNA-Seq analysis of blueberry fruit identifies candidate genes involved in ri...
RNA-Seq analysis of blueberry fruit identifies candidate genes involved in ri...RNA-Seq analysis of blueberry fruit identifies candidate genes involved in ri...
RNA-Seq analysis of blueberry fruit identifies candidate genes involved in ri...Ann Loraine
 
2012 august 16 systems biology rna seq v2
2012 august 16 systems biology rna seq v22012 august 16 systems biology rna seq v2
2012 august 16 systems biology rna seq v2Anne Deslattes Mays
 
Introduction to Galaxy and RNA-Seq
Introduction to Galaxy and RNA-SeqIntroduction to Galaxy and RNA-Seq
Introduction to Galaxy and RNA-SeqEnis Afgan
 
Catalyzing Plant Science Research with RNA-seq
Catalyzing Plant Science Research with RNA-seqCatalyzing Plant Science Research with RNA-seq
Catalyzing Plant Science Research with RNA-seqManjappa Ganiger
 
Bioo Scientific - Reduced Bias Small RNA Library Prep with Gel-Free or Low-In...
Bioo Scientific - Reduced Bias Small RNA Library Prep with Gel-Free or Low-In...Bioo Scientific - Reduced Bias Small RNA Library Prep with Gel-Free or Low-In...
Bioo Scientific - Reduced Bias Small RNA Library Prep with Gel-Free or Low-In...Bioo Scientific
 
Galaxy RNA-Seq Analysis: Tuxedo Protocol
Galaxy RNA-Seq Analysis: Tuxedo ProtocolGalaxy RNA-Seq Analysis: Tuxedo Protocol
Galaxy RNA-Seq Analysis: Tuxedo ProtocolHong ChangBum
 
Correcting bias and variation in small RNA sequencing for optimal (microRNA) ...
Correcting bias and variation in small RNA sequencing for optimal (microRNA) ...Correcting bias and variation in small RNA sequencing for optimal (microRNA) ...
Correcting bias and variation in small RNA sequencing for optimal (microRNA) ...Christos Argyropoulos
 
RNA-seq differential expression analysis
RNA-seq differential expression analysisRNA-seq differential expression analysis
RNA-seq differential expression analysismikaelhuss
 
RNA-seq: general concept, goal and experimental design - part 1
RNA-seq: general concept, goal and experimental design - part 1RNA-seq: general concept, goal and experimental design - part 1
RNA-seq: general concept, goal and experimental design - part 1BITS
 

Destaque (13)

single-cell-sequencing-research-review
single-cell-sequencing-research-reviewsingle-cell-sequencing-research-review
single-cell-sequencing-research-review
 
Analysis of Single-Cell Sequencing Data by CLC/Ingenuity: Single Cell Analysi...
Analysis of Single-Cell Sequencing Data by CLC/Ingenuity: Single Cell Analysi...Analysis of Single-Cell Sequencing Data by CLC/Ingenuity: Single Cell Analysi...
Analysis of Single-Cell Sequencing Data by CLC/Ingenuity: Single Cell Analysi...
 
RNA-Seq analysis of blueberry fruit identifies candidate genes involved in ri...
RNA-Seq analysis of blueberry fruit identifies candidate genes involved in ri...RNA-Seq analysis of blueberry fruit identifies candidate genes involved in ri...
RNA-Seq analysis of blueberry fruit identifies candidate genes involved in ri...
 
Rna seq pipeline
Rna seq pipelineRna seq pipeline
Rna seq pipeline
 
2012 august 16 systems biology rna seq v2
2012 august 16 systems biology rna seq v22012 august 16 systems biology rna seq v2
2012 august 16 systems biology rna seq v2
 
Introduction to Galaxy and RNA-Seq
Introduction to Galaxy and RNA-SeqIntroduction to Galaxy and RNA-Seq
Introduction to Galaxy and RNA-Seq
 
Catalyzing Plant Science Research with RNA-seq
Catalyzing Plant Science Research with RNA-seqCatalyzing Plant Science Research with RNA-seq
Catalyzing Plant Science Research with RNA-seq
 
Bioo Scientific - Reduced Bias Small RNA Library Prep with Gel-Free or Low-In...
Bioo Scientific - Reduced Bias Small RNA Library Prep with Gel-Free or Low-In...Bioo Scientific - Reduced Bias Small RNA Library Prep with Gel-Free or Low-In...
Bioo Scientific - Reduced Bias Small RNA Library Prep with Gel-Free or Low-In...
 
Single cell protein
Single cell proteinSingle cell protein
Single cell protein
 
Galaxy RNA-Seq Analysis: Tuxedo Protocol
Galaxy RNA-Seq Analysis: Tuxedo ProtocolGalaxy RNA-Seq Analysis: Tuxedo Protocol
Galaxy RNA-Seq Analysis: Tuxedo Protocol
 
Correcting bias and variation in small RNA sequencing for optimal (microRNA) ...
Correcting bias and variation in small RNA sequencing for optimal (microRNA) ...Correcting bias and variation in small RNA sequencing for optimal (microRNA) ...
Correcting bias and variation in small RNA sequencing for optimal (microRNA) ...
 
RNA-seq differential expression analysis
RNA-seq differential expression analysisRNA-seq differential expression analysis
RNA-seq differential expression analysis
 
RNA-seq: general concept, goal and experimental design - part 1
RNA-seq: general concept, goal and experimental design - part 1RNA-seq: general concept, goal and experimental design - part 1
RNA-seq: general concept, goal and experimental design - part 1
 

Semelhante a Introduction to Single-cell RNA-seq

Making powerful science: an introduction to NGS and beyond
Making powerful science: an introduction to NGS and beyondMaking powerful science: an introduction to NGS and beyond
Making powerful science: an introduction to NGS and beyondAdamCribbs1
 
High Throughput Sequencing Technologies: What We Can Know
High Throughput Sequencing Technologies: What We Can KnowHigh Throughput Sequencing Technologies: What We Can Know
High Throughput Sequencing Technologies: What We Can KnowBrian Krueger
 
AdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
AdamAmeur_SciLife_Bioinfo_course_Nov2015.pptAdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
AdamAmeur_SciLife_Bioinfo_course_Nov2015.pptRuthMWinnie
 
AdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
AdamAmeur_SciLife_Bioinfo_course_Nov2015.pptAdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
AdamAmeur_SciLife_Bioinfo_course_Nov2015.pptEdizonJambormias2
 
Next generation sequencing methods
Next generation sequencing methods Next generation sequencing methods
Next generation sequencing methods Mrinal Vashisth
 
How to cluster and sequence an ngs library (james hadfield160416)
How to cluster and sequence an ngs library (james hadfield160416)How to cluster and sequence an ngs library (james hadfield160416)
How to cluster and sequence an ngs library (james hadfield160416)James Hadfield
 
High Throughput Sequencing Technologies: On the path to the $0* genome
High Throughput Sequencing Technologies: On the path to the $0* genomeHigh Throughput Sequencing Technologies: On the path to the $0* genome
High Throughput Sequencing Technologies: On the path to the $0* genomeBrian Krueger
 
Cignal lenti webinar
Cignal lenti webinarCignal lenti webinar
Cignal lenti webinarElsa von Licy
 
GLBIO/CCBC Metagenomics Workshop
GLBIO/CCBC Metagenomics WorkshopGLBIO/CCBC Metagenomics Workshop
GLBIO/CCBC Metagenomics WorkshopMorgan Langille
 
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
 
Rnaseq basics ngs_application1
Rnaseq basics ngs_application1Rnaseq basics ngs_application1
Rnaseq basics ngs_application1Yaoyu Wang
 
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
 
Learning from nature or human body as a source on inspiration for software en...
Learning from nature or human body as a source on inspiration for software en...Learning from nature or human body as a source on inspiration for software en...
Learning from nature or human body as a source on inspiration for software en...b0ris_1
 
Semi Automated Low-throughput Workflow for Microbial Analyses of Human Stool
Semi Automated Low-throughput Workflow for Microbial Analyses of Human StoolSemi Automated Low-throughput Workflow for Microbial Analyses of Human Stool
Semi Automated Low-throughput Workflow for Microbial Analyses of Human StoolQIAGEN
 
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
 
wings2014 Workshop 1 Design, sequence, align, count, visualize
wings2014 Workshop 1 Design, sequence, align, count, visualizewings2014 Workshop 1 Design, sequence, align, count, visualize
wings2014 Workshop 1 Design, sequence, align, count, visualizeAnn Loraine
 

Semelhante a Introduction to Single-cell RNA-seq (20)

Making powerful science: an introduction to NGS and beyond
Making powerful science: an introduction to NGS and beyondMaking powerful science: an introduction to NGS and beyond
Making powerful science: an introduction to NGS and beyond
 
High Throughput Sequencing Technologies: What We Can Know
High Throughput Sequencing Technologies: What We Can KnowHigh Throughput Sequencing Technologies: What We Can Know
High Throughput Sequencing Technologies: What We Can Know
 
AdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
AdamAmeur_SciLife_Bioinfo_course_Nov2015.pptAdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
AdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
 
AdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
AdamAmeur_SciLife_Bioinfo_course_Nov2015.pptAdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
AdamAmeur_SciLife_Bioinfo_course_Nov2015.ppt
 
Next generation sequencing methods
Next generation sequencing methods Next generation sequencing methods
Next generation sequencing methods
 
How to cluster and sequence an ngs library (james hadfield160416)
How to cluster and sequence an ngs library (james hadfield160416)How to cluster and sequence an ngs library (james hadfield160416)
How to cluster and sequence an ngs library (james hadfield160416)
 
High Throughput Sequencing Technologies: On the path to the $0* genome
High Throughput Sequencing Technologies: On the path to the $0* genomeHigh Throughput Sequencing Technologies: On the path to the $0* genome
High Throughput Sequencing Technologies: On the path to the $0* genome
 
Cignal lenti webinar
Cignal lenti webinarCignal lenti webinar
Cignal lenti webinar
 
GLBIO/CCBC Metagenomics Workshop
GLBIO/CCBC Metagenomics WorkshopGLBIO/CCBC Metagenomics Workshop
GLBIO/CCBC Metagenomics Workshop
 
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...
 
Whole exome sequencing(wes)
Whole exome sequencing(wes)Whole exome sequencing(wes)
Whole exome sequencing(wes)
 
Rnaseq basics ngs_application1
Rnaseq basics ngs_application1Rnaseq basics ngs_application1
Rnaseq basics ngs_application1
 
Cignal lenti
Cignal lentiCignal lenti
Cignal lenti
 
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
 
Learning from nature or human body as a source on inspiration for software en...
Learning from nature or human body as a source on inspiration for software en...Learning from nature or human body as a source on inspiration for software en...
Learning from nature or human body as a source on inspiration for software en...
 
NGS.pptx
NGS.pptxNGS.pptx
NGS.pptx
 
Microbial physiology in genomic era
Microbial physiology in genomic eraMicrobial physiology in genomic era
Microbial physiology in genomic era
 
Semi Automated Low-throughput Workflow for Microbial Analyses of Human Stool
Semi Automated Low-throughput Workflow for Microbial Analyses of Human StoolSemi Automated Low-throughput Workflow for Microbial Analyses of Human Stool
Semi Automated Low-throughput Workflow for Microbial Analyses of Human Stool
 
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
 
wings2014 Workshop 1 Design, sequence, align, count, visualize
wings2014 Workshop 1 Design, sequence, align, count, visualizewings2014 Workshop 1 Design, sequence, align, count, visualize
wings2014 Workshop 1 Design, sequence, align, count, visualize
 

Último

The dark energy paradox leads to a new structure of spacetime.pptx
The dark energy paradox leads to a new structure of spacetime.pptxThe dark energy paradox leads to a new structure of spacetime.pptx
The dark energy paradox leads to a new structure of spacetime.pptxEran Akiva Sinbar
 
Davis plaque method.pptx recombinant DNA technology
Davis plaque method.pptx recombinant DNA technologyDavis plaque method.pptx recombinant DNA technology
Davis plaque method.pptx recombinant DNA technologycaarthichand2003
 
Forensic limnology of diatoms by Sanjai.pptx
Forensic limnology of diatoms by Sanjai.pptxForensic limnology of diatoms by Sanjai.pptx
Forensic limnology of diatoms by Sanjai.pptxkumarsanjai28051
 
Pests of soyabean_Binomics_IdentificationDr.UPR.pdf
Pests of soyabean_Binomics_IdentificationDr.UPR.pdfPests of soyabean_Binomics_IdentificationDr.UPR.pdf
Pests of soyabean_Binomics_IdentificationDr.UPR.pdfPirithiRaju
 
GenBio2 - Lesson 1 - Introduction to Genetics.pptx
GenBio2 - Lesson 1 - Introduction to Genetics.pptxGenBio2 - Lesson 1 - Introduction to Genetics.pptx
GenBio2 - Lesson 1 - Introduction to Genetics.pptxBerniceCayabyab1
 
Base editing, prime editing, Cas13 & RNA editing and organelle base editing
Base editing, prime editing, Cas13 & RNA editing and organelle base editingBase editing, prime editing, Cas13 & RNA editing and organelle base editing
Base editing, prime editing, Cas13 & RNA editing and organelle base editingNetHelix
 
Behavioral Disorder: Schizophrenia & it's Case Study.pdf
Behavioral Disorder: Schizophrenia & it's Case Study.pdfBehavioral Disorder: Schizophrenia & it's Case Study.pdf
Behavioral Disorder: Schizophrenia & it's Case Study.pdfSELF-EXPLANATORY
 
(9818099198) Call Girls In Noida Sector 14 (NOIDA ESCORTS)
(9818099198) Call Girls In Noida Sector 14 (NOIDA ESCORTS)(9818099198) Call Girls In Noida Sector 14 (NOIDA ESCORTS)
(9818099198) Call Girls In Noida Sector 14 (NOIDA ESCORTS)riyaescorts54
 
Pests of Blackgram, greengram, cowpea_Dr.UPR.pdf
Pests of Blackgram, greengram, cowpea_Dr.UPR.pdfPests of Blackgram, greengram, cowpea_Dr.UPR.pdf
Pests of Blackgram, greengram, cowpea_Dr.UPR.pdfPirithiRaju
 
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTXALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTXDole Philippines School
 
STOPPED FLOW METHOD & APPLICATION MURUGAVENI B.pptx
STOPPED FLOW METHOD & APPLICATION MURUGAVENI B.pptxSTOPPED FLOW METHOD & APPLICATION MURUGAVENI B.pptx
STOPPED FLOW METHOD & APPLICATION MURUGAVENI B.pptxMurugaveni B
 
Harmful and Useful Microorganisms Presentation
Harmful and Useful Microorganisms PresentationHarmful and Useful Microorganisms Presentation
Harmful and Useful Microorganisms Presentationtahreemzahra82
 
Citronella presentation SlideShare mani upadhyay
Citronella presentation SlideShare mani upadhyayCitronella presentation SlideShare mani upadhyay
Citronella presentation SlideShare mani upadhyayupadhyaymani499
 
BIOETHICS IN RECOMBINANT DNA TECHNOLOGY.
BIOETHICS IN RECOMBINANT DNA TECHNOLOGY.BIOETHICS IN RECOMBINANT DNA TECHNOLOGY.
BIOETHICS IN RECOMBINANT DNA TECHNOLOGY.PraveenaKalaiselvan1
 
Four Spheres of the Earth Presentation.ppt
Four Spheres of the Earth Presentation.pptFour Spheres of the Earth Presentation.ppt
Four Spheres of the Earth Presentation.pptJoemSTuliba
 
Call Girls in Munirka Delhi 💯Call Us 🔝8264348440🔝
Call Girls in Munirka Delhi 💯Call Us 🔝8264348440🔝Call Girls in Munirka Delhi 💯Call Us 🔝8264348440🔝
Call Girls in Munirka Delhi 💯Call Us 🔝8264348440🔝soniya singh
 
Call Girls In Nihal Vihar Delhi ❤️8860477959 Looking Escorts In 24/7 Delhi NCR
Call Girls In Nihal Vihar Delhi ❤️8860477959 Looking Escorts In 24/7 Delhi NCRCall Girls In Nihal Vihar Delhi ❤️8860477959 Looking Escorts In 24/7 Delhi NCR
Call Girls In Nihal Vihar Delhi ❤️8860477959 Looking Escorts In 24/7 Delhi NCRlizamodels9
 
THE ROLE OF PHARMACOGNOSY IN TRADITIONAL AND MODERN SYSTEM OF MEDICINE.pptx
THE ROLE OF PHARMACOGNOSY IN TRADITIONAL AND MODERN SYSTEM OF MEDICINE.pptxTHE ROLE OF PHARMACOGNOSY IN TRADITIONAL AND MODERN SYSTEM OF MEDICINE.pptx
THE ROLE OF PHARMACOGNOSY IN TRADITIONAL AND MODERN SYSTEM OF MEDICINE.pptxNandakishor Bhaurao Deshmukh
 

Último (20)

Hot Sexy call girls in Moti Nagar,🔝 9953056974 🔝 escort Service
Hot Sexy call girls in  Moti Nagar,🔝 9953056974 🔝 escort ServiceHot Sexy call girls in  Moti Nagar,🔝 9953056974 🔝 escort Service
Hot Sexy call girls in Moti Nagar,🔝 9953056974 🔝 escort Service
 
The dark energy paradox leads to a new structure of spacetime.pptx
The dark energy paradox leads to a new structure of spacetime.pptxThe dark energy paradox leads to a new structure of spacetime.pptx
The dark energy paradox leads to a new structure of spacetime.pptx
 
Davis plaque method.pptx recombinant DNA technology
Davis plaque method.pptx recombinant DNA technologyDavis plaque method.pptx recombinant DNA technology
Davis plaque method.pptx recombinant DNA technology
 
Forensic limnology of diatoms by Sanjai.pptx
Forensic limnology of diatoms by Sanjai.pptxForensic limnology of diatoms by Sanjai.pptx
Forensic limnology of diatoms by Sanjai.pptx
 
Pests of soyabean_Binomics_IdentificationDr.UPR.pdf
Pests of soyabean_Binomics_IdentificationDr.UPR.pdfPests of soyabean_Binomics_IdentificationDr.UPR.pdf
Pests of soyabean_Binomics_IdentificationDr.UPR.pdf
 
GenBio2 - Lesson 1 - Introduction to Genetics.pptx
GenBio2 - Lesson 1 - Introduction to Genetics.pptxGenBio2 - Lesson 1 - Introduction to Genetics.pptx
GenBio2 - Lesson 1 - Introduction to Genetics.pptx
 
Base editing, prime editing, Cas13 & RNA editing and organelle base editing
Base editing, prime editing, Cas13 & RNA editing and organelle base editingBase editing, prime editing, Cas13 & RNA editing and organelle base editing
Base editing, prime editing, Cas13 & RNA editing and organelle base editing
 
Behavioral Disorder: Schizophrenia & it's Case Study.pdf
Behavioral Disorder: Schizophrenia & it's Case Study.pdfBehavioral Disorder: Schizophrenia & it's Case Study.pdf
Behavioral Disorder: Schizophrenia & it's Case Study.pdf
 
(9818099198) Call Girls In Noida Sector 14 (NOIDA ESCORTS)
(9818099198) Call Girls In Noida Sector 14 (NOIDA ESCORTS)(9818099198) Call Girls In Noida Sector 14 (NOIDA ESCORTS)
(9818099198) Call Girls In Noida Sector 14 (NOIDA ESCORTS)
 
Pests of Blackgram, greengram, cowpea_Dr.UPR.pdf
Pests of Blackgram, greengram, cowpea_Dr.UPR.pdfPests of Blackgram, greengram, cowpea_Dr.UPR.pdf
Pests of Blackgram, greengram, cowpea_Dr.UPR.pdf
 
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTXALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
ALL ABOUT MIXTURES IN GRADE 7 CLASS PPTX
 
Volatile Oils Pharmacognosy And Phytochemistry -I
Volatile Oils Pharmacognosy And Phytochemistry -IVolatile Oils Pharmacognosy And Phytochemistry -I
Volatile Oils Pharmacognosy And Phytochemistry -I
 
STOPPED FLOW METHOD & APPLICATION MURUGAVENI B.pptx
STOPPED FLOW METHOD & APPLICATION MURUGAVENI B.pptxSTOPPED FLOW METHOD & APPLICATION MURUGAVENI B.pptx
STOPPED FLOW METHOD & APPLICATION MURUGAVENI B.pptx
 
Harmful and Useful Microorganisms Presentation
Harmful and Useful Microorganisms PresentationHarmful and Useful Microorganisms Presentation
Harmful and Useful Microorganisms Presentation
 
Citronella presentation SlideShare mani upadhyay
Citronella presentation SlideShare mani upadhyayCitronella presentation SlideShare mani upadhyay
Citronella presentation SlideShare mani upadhyay
 
BIOETHICS IN RECOMBINANT DNA TECHNOLOGY.
BIOETHICS IN RECOMBINANT DNA TECHNOLOGY.BIOETHICS IN RECOMBINANT DNA TECHNOLOGY.
BIOETHICS IN RECOMBINANT DNA TECHNOLOGY.
 
Four Spheres of the Earth Presentation.ppt
Four Spheres of the Earth Presentation.pptFour Spheres of the Earth Presentation.ppt
Four Spheres of the Earth Presentation.ppt
 
Call Girls in Munirka Delhi 💯Call Us 🔝8264348440🔝
Call Girls in Munirka Delhi 💯Call Us 🔝8264348440🔝Call Girls in Munirka Delhi 💯Call Us 🔝8264348440🔝
Call Girls in Munirka Delhi 💯Call Us 🔝8264348440🔝
 
Call Girls In Nihal Vihar Delhi ❤️8860477959 Looking Escorts In 24/7 Delhi NCR
Call Girls In Nihal Vihar Delhi ❤️8860477959 Looking Escorts In 24/7 Delhi NCRCall Girls In Nihal Vihar Delhi ❤️8860477959 Looking Escorts In 24/7 Delhi NCR
Call Girls In Nihal Vihar Delhi ❤️8860477959 Looking Escorts In 24/7 Delhi NCR
 
THE ROLE OF PHARMACOGNOSY IN TRADITIONAL AND MODERN SYSTEM OF MEDICINE.pptx
THE ROLE OF PHARMACOGNOSY IN TRADITIONAL AND MODERN SYSTEM OF MEDICINE.pptxTHE ROLE OF PHARMACOGNOSY IN TRADITIONAL AND MODERN SYSTEM OF MEDICINE.pptx
THE ROLE OF PHARMACOGNOSY IN TRADITIONAL AND MODERN SYSTEM OF MEDICINE.pptx
 

Introduction to Single-cell RNA-seq

  • 1. Introduction to Single-cell RNA-Seq Wally the Welsh Corgi
  • 2. Connecting & Computer Preliminaries Make sure your workshop provided computer is connected to the “Broad” or “Broad Internal” wireless network. Please do not connect your personal items (laptop, phone, etc.) to these wireless networks; it will tax the wireless system and make the workshop less effective. The password for computers is “password”.
  • 3. Introduction to single-cell RNA-Seq Timothy Tickle Brian Haas Asma Bankapur Center for Cell Circuits Computational Genomics Workshop 2017
  • 4. We Know Tissues are Heterogeneous
  • 5. Cell Identity is More Than Histopathology A cell participates in multiple cell contexts. Multiple factors shape a cell’s identity - Membership in a taxonomy of cell types - Simultaneous time- dependent processes - Response to the environment - Spatial positioning
  • 6. Before We Get Started • Single-cell RNA-Seq (scRNA-Seq) analysis methodology is developing. – Give you a feel for the data. – Perform some analysis together. • There is a vivid diversity of methodology. – These technique will grow as the field does. – Why were these specific tools chosen? • This is a guided conversation through scRNA-Seq analysis. – Breadth and targeted depth. – There may be other opinions, if you have one, please speak up so we can all learn from it.
  • 7. • Sections will be hands-on. – Much can be applied to other analysis. – Strengthen those R ninja skills! – If you need, cut and pasting is available. • cut_and_paste.txt • There will be many cute corgi pictures. Before We Get Started
  • 8. We Will Attempt to Cover • Describe scRNA-Seq assays. • Comparing assays. • Sequence pipelines. • How do measured counts behave? • Concerns over study design. • Initial data exploration. • Gene and cell filtering. • Plotting genes. • Dimensional Reduction and plotting cells. • Differential expression. • Communicating your study.
  • 9. Section: scRNA-Seq Assays • There are many scRNA-Seq Assays, each differs: – Some commercialized – Full transcriptome vs 3’ – Less or more automated – Different levels of throughput – Differences in cost
  • 11. • Developed for single cell but can performed using total RNA. • Selects for poly-A tail. • Full transcript assay. – Uses template switching for 5' end capture. • Standard illumina sequencing. – Off-the-shelf products. • Hundreds of samples. • Often do not see UMI used. Smart-Seq2: Description Full transcript scRNA-Seq
  • 12. • Poly-A capture with 30nt polyT and 25nt 5' anchor sequence. • RT adding untemplated C • Template switching • Locked Nucleic Acid binds to untemplated C • RT switches template • Preamplification / cleanup • DNA fragmentation and adapter ligation together. • Gap Repair, enrich, purify. Smart-Seq2: Assay Overview
  • 15. Drop-seq: Description • Moved throughput from hundreds to thousands. • Droplet-based processing using microfluidics • Nanoliter scale aqueous drops in oil. • 3' End • Bead based (STAMPs). • Single-cell transcriptomes attached to microparticles. • Cell barcodes use split-pool synthesis. • Uses UMI (Unique Molecular Identifier). • RMT (Random Molecular Tag). • Degenerate synthesis.
  • 16. Drop-seq: Overview • Click Here for Drop-seq Video Abstract
  • 21. Drop-seq: Pointers • Droplet-based assays can have leaky RNA. • Before library generation wash off any medium (inhibits library generation). • Adding PBS and BSA (0.05-0.01%) can protect the cell. – Too much produces a residue making harvesting the beads difficult. • Filter all reagent with a 80 micron strainer before microfluidics. • Some purchased devices add a hydrophobic coating. – Can deteriorate (2 months at best). – Recoating does work (in-house).
  • 23. 10X: Description • Droplet-based, 3' mRNA. – GEM (Gel Bead in Emulsion) • Standardized instrumentation and reagents. • More high-throughput scaling to tens of thousands. • Less processing time. • Cell Ranger software is available for install.
  • 27. A Word on Sorting • After disassociating cells cells can be performed. • Know your cells, are they sticky, are they big? – Select an appropriate sized nozzle. • Don't sort too quickly (1-2k cells per second or lower) – The slower the more time cells sit in lysis after sorting – 10 minutes max in lysis (some say 30 minutes) • Calibrate speed of instrument with beads – Check alignment every 5-6 plates • Afterwards spin down to make sure cells are in lysis buffer – Flash freeze • Chloe Villani on sorting [click here]
  • 30. ERCC-based Benchmarking • Based on ERCC spike-ins. – Exogenous RNA-Spikins – No secondary structure – 25b polyA Tail • May be a conservative measurement given endogenous mRNA will have ~250b polyA. • Accuracy – How well the abundance levels correlated with known spiked-in amounts. • Sensitivity – Minimum number of input RNA molecules required to detect a spike-in.
  • 31. Sensitivity and Specificity Accuracy Great! Poor Sensitivity Bulk Great! Bulk CEL-Seq2 Drop-Seq 10XSmart-Seq2 10 molecules 1 molecule
  • 32. Final Thoughts • Different assays have different throughput. – SmartSeq2 < Drop-seq < 10X • SmartSeq2 is full transcript. • Plate-based methods get lysed in wells and so do not leak. – Droplet-based can have leaky RNA. • In Drop-seq assays RT happens outside the droplets – Can use harsher lysis buffers. – 10X needs lysis buffers compatible with the RT enzyme. • 10X is more standardized and comes with a pipeline. – Drop-seq is more customizable but more hands-on. • Cost per library varies greatly.
  • 34. Sequences Differ So Pipelines Differ • scRNA-Seq assays are different and produce different sequences – The sequence pipelines must be tailored to the sequence of interest. – Many pipelines are NOT compatible but many show similarities.
  • 35. Start with FASTQ Sequences FASTQ File Format Sequence Header cDNA Sequence Base Quality 4 Lines are 1 sequence
  • 36. Assays Differ in FASTQ Contents
  • 38. • Common functionality: trimming, alignment, generating count matrix. • Adds book keeping for cell barcodes and UMIs, bead error detection, cell barcode collapsing, UMI collapsing. Drop-seq: Pipeline Overview
  • 40. • Steps conceptually similar to the Drop-seq pipeline. 10X: Pipeline Overview
  • 42. • Much of the QC that is performed is using traditional tools. Sequence Level Quality Control
  • 43. Pipeline Section Summary • Single-cell RNA-Seq is a diverse ecosystem of assays. – Each assay has pros and cons. • Sequences derived from these assays are complex and vary. • Different pipelines are needed to address different sequence formats. – Common steps include: • Aligning • QC • Read counting.
  • 45. This is an Expression Matrix
  • 46. Genes Have Different Distributions
  • 47. Genes Have Different Distributions
  • 48. Genes Have Different Distributions
  • 49. Genes Have Different Distributions
  • 50. Genes Have Different Distributions
  • 51. • Zero inflation. – Drop-out event during reverse- transcription. – Genes with more expression have less zeros. – Complexity varies. • Transcription stochasticity. – Transcription bursting. – Coordinated transcription of multigene networks. – Over-dispersed counts. • Higher Resolution. – More sources of signal Underlying Biology
  • 52. Expression has Many Sources per Cell
  • 53. Data Analysis with UMIs Read Counts Counts by UMI Collapsed but Not Linear
  • 54. Summary of the Data • We are still understanding scData and how to apply it. – Data can be NOT normal. – Data can be Zero-inflated. – Data can be very noisy. – Cells vary in library complexity. – Can represent many “basis vectors” or sources of expression simultaneously. • Keeping these characteristics in analysis assumptions. • Tend to filter more conservatively with UMIs.
  • 55. Section: Study Design and scRNA-Seq
  • 56. scRNA-Seq Study Design • How many cells? – Can change depending on the variability of the biology and the expectation of finding rare populations. • How to design cell capture? – Single cell RNA-Seq is especially prone to technical batch affects (due to processing). • Use of UMIs • Use of ERCC spike-ins
  • 57. How Many Cells? • Satija lab online tool – satijalab.org/howmanycells
  • 58. Single Cell RNA-Seq and Batch Affects
  • 59. What is Study Confounding?
  • 62. Motivation: Why Am I Using R? • A lot of method development is happening in R. • Free / open source / open science. • Many supplemental computational biology packages. • Data science is an art. – Data often requires one to create and manipulate analysis. • This will allow you to experience key concepts in analysis.
  • 65. Today’s Data • To generate a comprehensive, validated classification scheme for the bipolar cells of the mouse retina. – Cone or rod type, ON or OFF, 9-12 subtypes (morphological) • ~44k cells from a transgenic mouse line marking BCs – After filtering 27k (we use 5k)
  • 66. Logistics: Importing Code Libraries • R Exercise
  • 68. What is a Sparse Matrix? • Sparse Matrix – A matrix where most of the elements are 0. • Dense Matrix – A matrix where most elements are not 0. • Many ways to efficiently represent a sparse matrix in memory. – Here, the underlying data structure is a coordinate list.
  • 69. 2D Arrays vs Coordinate Lists Can be optimal for dense matrices More optimal for sparse matrices VS
  • 71. Create a Seurat Object • R exercise
  • 72. Expression: Bulk RNA-Seq Definition In bulk RNA-Seq we learned counts are not expression. • Some counts belong to sequences which could go to many genes. • Some transcripts are longer than other so they get sequenced more. • Some samples are more deeply sequenced. • The data is not normally distributed. Depending on the scRNA-Seq assay these may be important. Seurat has assumptions it makes with it’s defaults – More appropriate for 3 prime assays.
  • 73. Count Preparation is Different Depending on the Source RSEM KALLISTO TPM RSEM KALLISTO Correct for Sequencing Depth Log2() + 1Log2() + 1 Correct for Sequencing Depth X / Column Total * 1E5 or 1E6 TPMSeurat Seurat Seurat No transcript length correction
  • 74. Prepping Counts For Seurat 3 prime- • Expected by Seurat. • Counts collapsed with UMIs. • Log2 transform (in Seurat). • Account for sequencing depth (in Seurat). Full Transcript Sequencing- • Can be used in Seurat. • TPM +1 transformed counts. • Log2 transform (in Seurat). • Sequencing depth is already accounted.
  • 75. Sometimes Averages are Not Useful Say you were standing with one foot in the oven and one foot in an ice bucket. According to the percentage people, you should be perfectly comfortable. –Bobby Bragan
  • 76. Filtering Genes: Averages are Less Useful
  • 80. What is Metadata? Other information that describes your measurements. – Patient information. • Life style (smoking), Patient Biology (age), Comorbidity – Study information. • Treatment, Cage, Sequencing Site, Sequencing Date – Sequence QC on cells. • Useful in filtering.
  • 81. Filtering Cells: Removing Outlier Cells • Bulk RNA-Seq studies often do not remove outliers cells – scRNA-Seq often removes “failed libraries”. • Outlier cells are not just measured by complexity • Percent Reads Mapping • Percent Mitochondrial Reads • Presence of marker genes • Intergenic/ exonic rate • 5' or 3' bias • other metadata … • Useful Tools – Picard Tools and RNASeQC
  • 82. Seurat: Filtering on Metadata • R Exercise
  • 84. Seurat: Viewing Specific Genes • R Exercise
  • 85. Section: Working with Batch Affects
  • 86. Normalization and Batch Affect Correction • The nature of scRNA-Seq assays can make them prone to confounding with batch affects. – Normalization and batch affect correction can help. • Some are moving away from relying on a specific method. – Exploring the idea of combining or selecting from a collection of normalization or correction methods best for a specific study. • Some believe UMI based analysis need not be normalized between samples given the absolute count of the molecules are being reported. – Be careful not to remove biological signal with good experimental design (avoiding confounding by design).
  • 87. Seurat and Batch Affect Correction • Using linear models one can regress covariates. – scale.data hold the residuals after regressing (z-scored) • Dimensionality reduction and clustering. • We use metadata we have. – One could imagine creating a metadata for cell cycle.
  • 88. Seurat and Batch Affect Correction • R exercise
  • 89. Section: Dimensionality Reduction and Plotting Samples
  • 90. Dimensionality Reduction • Start with many measurements (high dimensional). – Want to reduce to few features (lower-dimensional space). • One way is to extract features based on capturing groups of variance. • Another could be to preferentially select some of the current features. – We have already done this. • We need this to plot the cells in 2D (or ordinate them) • In scRNA-Seq PC1 may be complexity.
  • 91. • Eigenvectors of covariance matrix. • Find orthogonal groups of variance. • Given from most to least variance. – Components of variation. – Linear combinations explaining the variance. PCA: in Quick Theory
  • 92. PCA: an Interactive Example • PCA Explained Visually
  • 93. PCA: in Practice Things to be aware of- • Data with different magnitudes will dominate. – Zero center and divided by SD. • (Standardized). • Can be affected by outliers. • Data is often first filtered to remove noise.
  • 95. t-SNE: Collapsing the Visualization to 2D
  • 96. t-SNE: How it works.
  • 97. PCA and t-SNE Together • Often t-SNE is performed on PCA components – Liberal number of components. – Removes mild signal (assumption of noise). – Faster, on less data but, hopefully the same signal.
  • 98. Learn More About t-SNE • Awesome Blog on t-SNE parameterization – http://distill.pub/2016/misread-tsne • Publication – https://lvdmaaten.github.io/publications/papers/JMLR_200 8.pdf • Nice YouTube Video – https://www.youtube.com/watch?v=RJVL80Gg3lA • Code – https://lvdmaaten.github.io/tsne/ • Interactive Tensor flow – http://projector.tensorflow.org/
  • 100. Plotting Cells and Gene Expression • R exercise.
  • 101. • Smart Local Moving (SLM) algorithm for community (cluster) detection in large networks. – Can be applied to 10s of millions cells, 100s of millions of relationships. – Evolved from the Louvain algorithm Defining Clusters through Graphs http://www.ludowaltman.nl/slm/
  • 102. Local Moving Heuristic 1 2 3 4 5 6 7
  • 103. Section Summary • Dimensionality reduction help reduce data while hopefully keeping important signal. – t-SNE on PCA is often used in analysis • Created several types of plot often seen in publications. – Plotting genes (through subgroups). – Ordinating cells in t-SNE space. – Heat maps of genes associated with PC components. – Plotting metadata on projects of data is an important QC tool. • Cluster of cells are currently defined through graph, separate from the ordination (t-SNE / PCA).
  • 105. Seurat: Differential Expression • Default if one cluster again many tests. – Can specify an ident.2 test between clusters. • Adding speed by exluding tests. – Min.pct - controls for sparsity – Min percentage in a group – Thresh.test - must have this difference in averages.
  • 106. Seurat: Many Choices for DE • bimod – Tests differences in mean and proportions. • roc – Uses AUC like definition of separation. • t – Student's T-test. • tobit – Tobit regression on a smoothed data.
  • 107. Seurat: DE and Plotting DE Genes • R Exercise.
  • 108. Dot plots Size of circle • Gene prevalence in cluster. Color of circle • More red, more expressed in cluster. Scales well with many cells. sparse genesprevalent genes lowly expressed highly expressed very specific
  • 109. • Additionally introduces a GSEA method. Mast • Uses hurdle model – Two part generalized linear model to address both rate of expression (prevalence) and expression. – GLM means covariates can be used to control for unwanted signal. • CDR: Cellular detection rate – Cellular complexity – Values below a threshold are 0 https://github.com/RGLab/MAST
  • 110. Mast: Hurdle Models Logistic Regression Gaussian Linear Model
  • 111. Mast: DE and Plotting DE Genes • R Exercise.
  • 112. Section: Communicating Results to Collaborators • Designing a study. • Writing a grant. • Performing experiments. • Collecting data. • Running sequencing pipelines. • Performing some preliminary analysis. • Sharing ideas with private collaborators. • Refining analysis. • Completing a paper. • Sharing analysis publicly.
  • 113. The Single Cell Portal https://portals.broadinstitute.org/single_cell
  • 114. The Single Cell Portal Study Descriptions Can Be Created
  • 115. The Single Cell Portal Data Can Be Shared
  • 116. The Single Cell Portal One Can Interact with Cell Clusters
  • 117. The Single Cell Portal Gene Expression Can be Viewed Across Clusters
  • 118. The Single Cell Portal Gene Expression Can be Viewed Across Clusters
  • 119. The Single Cell Portal Multiple Clustering Can be Used
  • 120. The Single Cell Portal Genes Can Be Viewed in Many Clusters
  • 121. The Single Cell Portal Expression Can Be Shown in Many Clusterings
  • 122. The Single Cell Portal Expression in Clusters Can Also Be Shown as Heatmaps
  • 123. The Single Cell Portal • Studies can be … – Private – Private but shared privately – Public but with data inaccessible – Public
  • 124. Section: Wrapping Up What Did We Miss (So Much)? So much more to learn! We covered this
  • 127. Thank You Aviv Regev Brian Haas Adam Haber Anindita Basu Asma Bankapur Chloe Villani Karthik Shekhar Kristine Schwenck Matan Hofree Michel Cole Monika Kowalczyk Nir Yosef Sean Simmons Regev Single Cell Working Group Today's Attendees

Notas do Editor

  1. Lamina Propria- loose connective tissue Peristalsis Eosinophil-white blood cell that stains well with Eosin. Band neutrophil/Segmented neutrophil-Neutrophils, are also known as "segs", "PMNs" or "polys" (polymorphonuclears). They are the body's primary defense against bacterial infection and physiologic stress. Basophil-white blood cell Platelet-blood coting lymphocyte-immune system Monocyte-a large phagocytic white blood cell with a simple oval nucleus and clear, grayish cytoplasm.
  2. All have great accuracy. Some have better sensitivity than others: All better than bulk Many between 10 and 1 molecule detection Sensitivity is dependent on depth, you could sequence more deeply if needed. Sensitivity is critical when you are studying lowly expressed genes.
  3. The modularity of a network is a value that is between -1 and 1. This value presents the density of links inside communities over the density of links between communities.
  4. This is the louvain algorithm, the difference with this and the SLM is that when communities are made the community is broken down to nodes and then larger communities are recreated, incase one node would better live in another community.