my scRNAseq analysis notes
Single cell RNAseq is becoming more and more popular, and as a technique, it might become as common as PCR. I just got some 10x genomics single cell RNAseq data to play with, it is a good time for me to take down notes here. I hope it is useful for other people as well.
- Course material in notebook format for learning about single cell bioinformatics methods
- Analysis of single cell RNA-seq data course, Cambridge University Great tutorial!
- Current best practices in single‐cell RNA‐seq analysis: a tutorial github repo https://github.com/theislab/single-cell-tutorial
- f1000 workflow paper A step-by-step workflow for low-level analysis of single-cell RNA-seq data by Aaron Lun, the athour of diffHiC, GenomicInteractions and csaw.
- SimplesingleCell A step-by-step workflow for low-level analysis of single-cell RNA-seq data with Bioconductor by Aaron Lun as well!
- 2016 Bioconductor workshop: Analysis of single-cell RNA-seq data with R and Bioconductor
- Orchestrating Single-Cell Analysis with Bioconductor
- paper: Single-Cell Transcriptomics Bioinformatics and Computational Challenges
- Single Cell RNA-seq (scRNA-seq) Library Structure
- Variance stabilizing scRNA-seq counts is log2(x+1) reasonable?
- Aaron Lun’s single-cell thoughts on Linearity, Transformation, Standardization, Clustering, Cellular detection rate and Bootstrapping.
- How to tune hyperparameters of tSNE
- How to cluster in High Dimensions
- Deep Learning for Single Cell Biology
- 12 Grand challenges in single-cell data science
- Single-Cell RNA Sequencing in Cancer: Lessons Learned and Emerging Challenges
- A Single-Cell Sequencing Guide for Immunologists
- paper: Design and Analysis of Single-Cell Sequencing Experiments
- paper: Experimental design for single-cell RNA sequencing
- paper: How to design a single-cell RNA-sequencing experiment: pitfalls, challenges and perspectives
- GT-TS: Experimental design for maximizing cell type discovery in single-cell data
- Tutorial: guidelines for the experimental design of single-cell RNA sequencing studies
- paper: Performance Assessment and Selection of Normalization Procedures for Single-Cell RNA-Seq
- paper: Assessment of single cell RNA-seq normalization methods
- paper: A practical guide to single-cell RNA-sequencing for biomedical research and clinical applications
- Normalizing single-cell RNA sequencing data: challenges and opportunities Nature Methods
- SinQC: A Method and Tool to Control Single-cell RNA-seq Data Quality.
- Scone Single-Cell Overview of Normalized Expression data
-
SAVER: gene expression recovery for single-cell RNA sequencing an expression recovery method for unique molecule index (UMI)-based scRNA-seq data that borrows information across genes and cells to provide accurate expression estimates for all genes.
-
DeepImpute: an accurate, fast and scalable deep neural network method to impute single-cell RNA-Seq data https://www.biorxiv.org/content/early/2018/06/22/353607
-
MAGIC (Markov Affinity-based Graph Imputation of Cells), is a method for imputing missing values restoring structure of large biological datasets.
-
bayNorm: Bayesian gene expression recovery, imputation and normalisation for single cell RNA-sequencing data github page
-
Zero-preserving imputation of scRNA-seq data using low-rank approximation
-
Overcoming confounding plate effects in differential expression analyses of single-cell RNA-seq data
-
Batch effects in single-cell RNA-sequencing data are corrected by matching mutual nearest neighbors
-
Panoramic stitching of heterogeneous single-cell transcriptomic data Here we present Scanorama, inspired by algorithms for panorama stitching, that overcomes the limitations of existing methods to enable accurate, heterogeneous scRNA-seq data set integration.
-
Fast Batch Alignment of Single Cell Transcriptomes Unifies Multiple Mouse Cell Atlases into an Integrated Landscape github link
-
Scalable integration of single cell RNAseq data for batch correction and meta analysis
-
ligerR package for integrating and analyzing multiple single-cell datasets
-
MatchScore2 paper: Benchmarking Single-Cell RNA Sequencing Protocols for Cell Atlas Projects
-
Benchmarking single cell RNA-sequencing analysis pipelines using mixture control experiments code and data cellbench bioconductor package.
- A discriminative learning approach to differential expression analysis for single-cell RNA-seq by Lior Patcher group.
- scde bioconductor package maintained by Jean Fan in Xiaowei Zhuang's lab at Harvard. Need to talk to her once I get a chance.
- PrestoFast Wilcoxon and auROC for single cell RNAseq and scATACseq data. take a look!
- How to compare clusters with multiple samples? https://twitter.com/RoryKirchner/status/1082752967806210048 . work in progess https://github.com/HelenaLC/muscat by Helena from Mark Robinson lab. bioc2019 workshop http://biocworkshops2019.bioconductor.org.s3-website-us-east-1.amazonaws.com/page/muscWorkshop__vignette/ and a blog post by VALENTINE SVENSSON from Lior Patcher's group http://www.nxn.se/valent/2019/2/15/handling-confounded-samples-for-differential-expression-in-scrna-seq-experiments
- a collection of single RNA-seq tools by Sean Davis
- paper: Design and computational analysis of single-cell RNA-sequencing experiments
- paper by Mark Robinson: Bias, Robustness And Scalability In Differential Expression Analysis Of Single-Cell RNA-Seq Data
Considerable differences are found between the methods in terms of the number and characteristics of the genes that are called differentially expressed. Pre-filtering of lowly expressed genes can have important effects on the results, particularly for some of the methods originally developed for analysis of bulk RNA-seq data. Generally, however, methods developed for bulk RNA-seq analysis do not perform notably worse than those developed specifically for scRNA-seq.
- paper: Power Analysis of Single Cell RNA‐Sequencing Experiments
- paper: The contribution of cell cycle to heterogeneity in single-cell RNA-seq data
- paper: Batch effects and the effective design of single-cell gene expression studies
- On the widespread and critical impact of systematic bias and batch effects in single-cell RNA-Seq data
- paper: Comparison of methods to detect differentially expressed genes between single-cell populations
- review: Single-cell genome sequencing: current state of the science
- Ginkgo A web tool for analyzing single-cell sequencing data.
- SingleCellExperiment bioc package Defines a S4 class for storing data from single-cell experiments. This includes specialized methods to store and retrieve spike-in information, dimensionality reduction coordinates and size factors for each cell, along with the usual metadata for genes and libraries.
- ASAP: a Web-based platform for the analysis and inter-active visualization of single-cell RNA-seq data
- Seurat is an R package designed for the analysis and visualization of single cell RNA-seq data. It contains easy-to-use implementations of commonly used analytical techniques, including the identification of highly variable genes, dimensionality reduction (PCA, ICA, t-SNE), standard unsupervised clustering algorithms (density clustering, hierarchical clustering, k-means), and the discovery of differentially expressed genes and markers.
- R package for the statistical assessment of cell state hierarchies from single-cell RNA-seq data
- Monocle Differential expression and time-series analysis for single-cell RNA-Seq and qPCR experiments.
- Single Cell Differential Expression: bioconductor package scde
- Sincera:A Computational Pipeline for Single Cell RNA-Seq Profiling Analysis. Bioconductor package will be available soon.
- MAST: a flexible statistical framework for assessing transcriptional changes and characterizing heterogeneity in single-cell RNA sequencing data
- scDD: A statistical approach for identifying differential distributions in single-cell RNA-seq experiments
- Inference and visualisation of Single-Cell RNA-seq Data data as a hierarchical tree structure: bioconductor CellTree
- Fast and accurate single-cell RNA-Seq analysis by clustering of transcript-compatibility counts by Lior Pachter et.al
- cellity: Classification of low quality cells in scRNA-seq data using R.
- bioconductor: using scran to perform basic analyses of single-cell RNA-seq data
- scater: single-cell analysis toolkit for expression with R
- Monovar: single-nucleotide variant detection in single cells
- paper: Comparison of methods to detect differentially expressed genes between single-cell populations
- Single-cell mRNA quantification and differential analysis with Census
- CIDR: Ultrafast and accurate clustering through imputation for single-cell RNA-seq data
- CellView: Interactive Exploration Of High Dimensional Single Cell RNA-Seq Data
- Scanpy is a scalable toolkit for analyzing single-cell gene expression data. It includes preprocessing, visualization, clustering, pseudotime and trajectory inference, differential expression testing and simulation of gene regulatory networks. The Python-based implementation efficiently deals with datasets of more than one million cells.
- Single cell perturbation prediction https://scgen.readthedocs.io A tensorflow implementation of scGen. scGen is a generative model to predict single-cell perturbation response across cell types, studies and species.
- scMatch: a single-cell gene expression profile annotation tool using reference datasets
- Celaref
- MetaNeighbour
- scID
- scMCA
- scPred
- SingleR
- singleCellNet
- Single Cell Clustering Comparison A blog post.
- A systematic performance evaluation of clustering methods for single-cell RNA-seq data F1000 paper by Mark Robinson. tl;dr version: "SC3 and Seurat show the most favorable results".
- Geometry of the Gene Expression Space of Individual Cells
- pcaReduce: Hierarchical Clustering of Single Cell Transcriptional Profiles.
- CountClust: Clustering and Visualizing RNA-Seq Expression Data using Grade of Membership Models. Fits grade of membership models (GoM, also known as admixture models) to cluster RNA-seq gene expression count data, identifies characteristic genes driving cluster memberships, and provides a visual summary of the cluster memberships
- FastProject: A Tool for Low-Dimensional Analysis of Single-Cell RNA-Seq Data
- SNN-Cliq Identification of cell types from single-cell transcriptomes using a novel clustering method
- Compare clusterings for single-cell sequencing bioconductor package.The goal of this package is to encourage the user to try many different clustering algorithms in one package structure. We give tools for running many different clusterings and choices of parameters. We also provide visualization to compare many different clusterings and algorithm tools to find common shared clustering patterns.
- CIDR: Ultrafast and accurate clustering through imputation for single cell RNA-Seq data
- SC3- consensus clustering of single-cell RNA-Seq data. SC3 achieves high accuracy and robustness by consistently integrating different clustering solutions through a consensus approach. Tests on twelve published datasets show that SC3 outperforms five existing methods while remaining scalable, as shown by the analysis of a large dataset containing 44,808 cells. Moreover, an interactive graphical implementation makes SC3 accessible to a wide audience of users, and SC3 aids biological interpretation by identifying marker genes, differentially expressed genes and outlier cells.
- GiniClust2: a cluster-aware, weighted ensemble clustering method for cell-type detection
- FateID infers cell fate bias in multipotent progenitors from single-cell RNA-seq data
- matchSCore: Matching Single-Cell Phenotypes Across Tools and Experiments In this work we introduce matchSCore (https://github.com/elimereu/matchSCore), an approach to match cell populations fast across tools, experiments and technologies. We compared 14 computational methods and evaluated their accuracy in clustering and gene marker identification in simulated data sets.
- Cluster Headache: Comparing Clustering Tools for 10X Single Cell Sequencing Data
- The celaref (cell labelling by reference) package aims to streamline the cell-type identification step, by suggesting cluster labels on the basis of similarity to an already-characterised reference dataset - wheather that's from a similar experiment performed previously in the same lab, or from a public dataset from a similar sample.
- souporcell: Robust clustering of single cell RNAseq by genotype and ambient RNA inference without reference genotypes souporcell, a robust method to cluster cells by their genetic variants without a genotype reference and show that it outperforms existing methods on clustering accuracy, doublet detection, and genotyping across a wide range of challenging scenarios while accurately estimating the amount of ambient RNA in the sample
- Principal Component Analysis Explained Visually
- PCA, MDS, k-means, Hierarchical clustering and heatmap. I wrote it.
- horseshoe effect from PCA Spurious structures in latent space decomposition and low-dimensional embedding methods
- also read chapter 9 of http://web.stanford.edu/class/bios221/book/Chap-MultivaHetero.html
- A tale of two heatmaps. I wrote it.
- Heatmap demystified. I wrote it.
- Cluster Analysis in R - Unsupervised machine learning very practical intro on STHDA website.
- I wrote on PCA, and heatmaps on Rpub
- A most read for clustering analysis for high-dimentional biological data:Avoiding common pitfalls when clustering biological data
- How does gene expression clustering work? A must read for clustering.
- How to read PCA plots for scRNAseq by VALENTINE SVENSSON.
<script async src="//platform.twitter.com/widgets.js" charset="utf-8"></script>See https://t.co/yxCb85ctL1: "MDS best choice for preserving outliers, PCA for variance, & T-SNE for clusters" @mikelove @AndrewLBeam
— Rileen Sinha (@RileenSinha) August 25, 2016
paper: Outlier Preservation by Dimensionality Reduction Techniques
"MDS best choice for preserving outliers, PCA for variance, & T-SNE for clusters"
-
Rtsne R package for T-SNE
-
rtsne An R package for t-SNE (t-Distributed Stochastic Neighbor Embedding) a bug was in
rtsne
: https://gist.github.com/mikelove/74bbf5c41010ae1dc94281cface90d32 -
t-SNE-Heatmaps Beta version of 1D t-SNE heatmaps to visualize expression patterns of hundreds of genes simultaneously in scRNA-seq.
-
How to tune hyperparameters of tSNE For single-cell RNAseq: The optimal perplexity can be calculated from the number of cells according to the simple power law Perplexity ~ N^(1/2). Finally, the optimal number of iterations should provide the largest distance between the data points of ~100 units.
-
when to use PCA instead of t-SNE https://stats.stackexchange.com/questions/238538/are-there-cases-where-pca-is-more-suitable-than-t-sne/249520#249520
t-SNE is a great piece of Machine Learning but one can find many reasons to use PCA instead of it. Of the top of my head, I will mention five. As most other computational methodologies in use, t-SNE is no silver bullet and there are quite a few reasons that make it a suboptimal choice in some cases. Let me mention some points in brief:
Stochasticity of final solution. PCA is deterministic; t-SNE is not. One gets a nice visualisation and then her colleague gets another visualisation and then they get artistic which looks better and if a difference of 0.03% in the KL(P||Q) divergence is meaningful... In PCA the correct answer to the question posed is guaranteed. t-SNE might have multiple minima that might lead to different solutions. This necessitates multiple runs as well as raises questions about the reproducibility of the results.
Interpretability of mapping. This relates to the above point but let's assume that a team has agreed in a particular random seed/run. Now the question becomes what this shows... t-SNE tries to map only local / neighbours correctly so our insights from that embedding should be very cautious; global trends are not accurately represented (and that can be potentially a great thing for visualisation). On the other hand, PCA is just a diagonal rotation of our initial covariance matrix and the eigenvectors represent a new axial system in the space spanned by our original data. We can directly explain what a particular PCA does.
Application to new/unseen data. t-SNE is not learning a function from the original space to the new (lower) dimensional one and that's a problem. On that matter, t-SNE is a non-parametric learning algorithm so approximating with parametric algorithm is an ill-posed problem. The embedding is learned by directly moving the data across the low dimensional space. That means one does not get an eigenvector or a similar construct to use in new data. In contrast, using PCA the eigenvectors offer a new axes system what can be directly used to project new data. [Apparently one could try training a deep-network to learn the t-SNE mapping (you can hear Dr. van der Maaten at ~46' of this video suggesting something along this lines) but clearly no easy solution exists.]
Incomplete data. Natively t-SNE does not deal with incomplete data. In fairness, PCA does not deal with them either but numerous extensions of PCA for incomplete data (eg. probabilistic PCA) are out there and are almost standard modelling routines. t-SNE currently cannot handle incomplete data (aside obviously training a probabilistic PCA first and passing the PC scores to t-SNE as inputs).
The k is not (too) small case. t-SNE solves a problem known as the crowding problem, effectively that somewhat similar points in higher dimension collapsing on top of each other in lower dimensions (more here). Now as you increase the dimensions used the crowding problem gets less severe ie. the problem you are trying to solve through the use of t-SNE gets attenuated. You can work around this issue but it is not trivial. Therefore if you need a k dimensional vector as the reduced set and k is not quite small the optimality of the produce solution is in question. PCA on the other hand offer always the k best linear combination in terms of variance explained. (Thanks to @amoeba for noticing I made a mess when first trying to outline this point.)
I do not mention issues about computational requirements (eg. speed or memory size) nor issues about selecting relevant hyperparameters (eg. perplexity). I think these are internal issues of the t-SNE methodology and are irrelevant when comparing it to another algorithm.
To summarise, t-SNE is great but as all algorithms has its limitations when it comes to its applicability. I use t-SNE almost on any new dataset I get my hands on as an explanatory data analysis tool. I think though it has certain limitations that do not make it nearly as applicable as PCA. Let me stress that PCA is not perfect either; for example, the PCA-based visualisations are often inferior to those of t-SNE.
- projection to new data https://twitter.com/EduEyras/status/1032215352623747072
You can’t add samples to an existing tSNE plot because there is no function outputed by the initial tSNE that maps from the higher dimensional space to the lower dimensions
- Interpretable dimensionality reduction of single cell transcriptome data with deep generative models
UMAP is faster, the embeddings are often ++better, and you can use the result to project new data.
- PCA loadings can be used to project new data
e.g. from this paper Multi-stage Differentiation Defines Melanoma Subtypes with Differential Vulnerability to Drug-Induced Iron-Dependent Oxidative Stress Fig 1D.
diffStagePCA = prcomp(t(diffStageDataCentered))
# Diff stage PCA (scores for top panel)
diffStagePCA_scores = diffStagePCA$x
# Cell line projected to diff stage PCA (scores for bottom panel)
diffStagePCA_rotation = diffStagePCA$rotation
cellLineProjected_scores <- as.matrix(t(cellLineDataCentered)) %*% as.matrix(diffStagePCA_rotation)
-
Sleepwalk: Walk through your embedding So, can you be sure that the visualisation you get by using t-SNE, UMAP, MDS or the like really give you a faithful representation of your data? Are the points that lie almost on top of each other really all similar? Does the large distance on your 2D representation always mean lots of dissimilarities? Our sleepwalk package for the R statistical programming environment can help you answer these questions.
-
Generalizable and Scalable Visualization of Single-Cell Data Using Neural Networks standard methods, such as t-stochastic neighbor embedding (t-SNE), are not scalable to datasets with millions of cells and the resulting visualizations cannot be generalized to analyze new datasets. Here we introduce net-SNE, a generalizable visualization approach that trains a neural network to learn a mapping function from high-dimensional single-cell gene-expression profiles to a low-dimensional visualization.
-
PHATE dimensionality reduction method paper: http://biorxiv.org/content/early/2017/03/24/120378 PHATE also uncovers and emphasizes progression and transitions (when they exist) in the data, which are often missed in other visualization-capable methods. Such patterns are especially important in biological data that contain, for example, single-cell phenotypes at different phases of differentiation, patients at different stages of disease progression, and gut microbial compositions that vary gradually between individuals, even of the same enterotype.
-
Uniform Manifold Approximation and Projection (UMAP) is a dimension reduction technique that can be used for visualisation similarly to t-SNE, but also for general non-linear dimension reduction. The algorithm is founded on three assumptions about the data. Run from R: https://gist.github.com/crazyhottommy/caa5a4a4b07ee7f08f7d0649780832ef
-
umapr UMAP dimensionality reduction in R
-
uwot An R package implementing the UMAP dimensionality reduction method. UMAP multi-threaded.
-
Fast Fourier Transform-accelerated Interpolation-based t-SNE (FIt-SNE) The FIt-SNE implementation is generally faster than UMAP when you have more than 3,000 cells. In the realm of 10,000's of cells FIt-SNE scales at the same rate as UMAP. However, note that this is a log-log scale. Even if FI-tSNE starts scaling at the rate of UMAP, it is still consistently about 4 times faster. In other words, a dataset that takes an hour for UMAP will take 15 minutes for FIt-SNE. see the benchmark here https://nbviewer.jupyter.org/gist/vals/a138b6b13ae566403687a241712e693b by Valentine Svensson.
-
Parallel opt-SNE implementation with Python wrapper preprint:Automated optimal parameters for T-distributed stochastic neighbor embedding improve visualization and allow analysis of large datasets
- Scribe: Towards inferring causal regulations with single cell dynamics-coupled measurements
- single cell gene regulatory network analysis https://github.com/aertslab/SCENIC
- Single-Cell Transcriptomics Unveils Gene Regulatory Network Plasticity
- Single-Cell Signature Explorer for comprehensive visualization of single cell signatures across scRNA-seq datasets https://sites.google.com/site/fredsoftwares/products/single-cell-signature-explorer
- We have written a Python+R pipeline called "polyApipe" for identifying alternative polyadenylation (APA) sites in 10X Genomics scRNA-seq, based on the presence of polyadenylated reads. Once sites are identified, UMIs are counted for each site and the APA state of genes in cells can be determined. Given the sparse and noisy nature of this data, we have developed an R package "weitrix" to identify principal components of variation in APA based on measurements of varying accuracy and with many missing values. We then use varimax rotation to obtain independently interpretable components. In an embryonic mouse brain dataset, we identify 8 distinct components of APA variation, and assign biological meaning to each component in terms of the genes, cell type, and cell phase.
- CellMarker: a manually curated resource of cell markers in human and mouse
- scRNAseq bioc package Gene-level counts for a collection of public scRNA-seq datasets, provided as SingleCellExperiment objects with cell- and gene-level metadata.
- human cell atlas database
- EMBL-EBI atlas
- (PanglaoDB)[https://panglaodb.se/) is a database for the scientific community interested in exploration of single cell RNA sequencing experiments from mouse and human. We collect and integrate data from multiple studies and present them through a unified framework.
- scRNASeqDBdatabase, which contains 36 human single cell gene expression data sets collected from Gene Expression Omnibus (GEO)
- JingleBellA repository of standardized single cell RNA-Seq datasets for analysis and visualization at the single cell level.
- Broad single cell portal
- The conquer (consistent quantification of external rna-seq data) repository is developed by Charlotte Soneson and Mark D Robinson at the University of Zurich, Switzerland. It is implemented in shiny and provides access to consistently processed public single-cell RNA-seq data sets.
- A single-cell molecular map of mouse gastrulation and early organogenesis
- The single-cell transcriptional landscape of mammalian organogenesis
- Comparative analysis of droplet-based ultra-high-throughput single-cell RNA-seq systems
- scRNA-seq mixology: towards better benchmarking of single cell RNA-seq protocols and analysis methods github repo
- A Single-Cell Transcriptome Atlas of the Aging Drosophila Brain
- Bias, robustness and scalability in single-cell differential expression analysis by Mark Robinson
- Cell type transcriptome atlas for the planarian Schmidtea mediterranea
- Cell type atlas and lineage tree of a whole complex animal by single-cell transcriptomics
- Single-cell reconstruction of developmental trajectories during zebrafish embryogenesis
- The dynamics of gene expression in vertebrate embryogenesis at single-cell resolution
- Single-cell mapping of gene expression landscapes and lineage in the zebrafish embryo
- Decomposing cell identity for transfer learning across cellular measurements, platforms, tissues, and species
- The contribution of cell cycle to heterogeneity in single-cell RNA-seq data
- cellxgene An interactive explorer for single-cell transcriptomics data. Leveraging modern web development techniques to enable fast visualizations of at least 1 million cells, we hope to enable biologists and computational researchers to explore their data.
- scSVA from Aviv Regev lab: an interactive tool for big data visualization and exploration in single-cell omics. scSVA is memory efficient for more than hundreds of millions of cells, can be run locally or in a cloud, and generates high-quality figures.
- ASAP: a web-based platform for the analysis and interactive visualization of single-cell RNA-seq data
- iSEE Provides functions for creating an interactive Shiny-based graphical user interface for exploring data stored in SummarizedExperiment objects, including row- and column-level metadata. Particular attention is given to single-cell data in a SingleCellExperiment object with visualization of dimensionality reduction results.
- VISION A high-throughput and unbiased module for interpreting scRNA-seq data.
- scMerge
- Seurat V3
- Cons Joint analysis of heterogeneous single-cell RNA-seq dataset collections. Single-cell RNA sequencing is often applied in study designs that include multiple individuals, conditions or tissues. To identify recurrent cell subpopulations in such heterogeneous collections, we developed Conos, an approach that relies on multiple plausible inter-sample mappings to construct a global graph connecting all measured cells. The graph enables identification of recurrent cell clusters and propagation of information between datasets in multi-sample or atlas-scale collections. published in Nature Methods
- scAlign Bioconductor package. a tool for alignment, integration, and rare cell identification from scRNA-seq data
- Linking transcriptional and genetic tumor heterogeneity through allele analysis of single-cell RNA-seq data. tool HoneyBADGER
-
Single-cell profiling of the developing mouse brain and spinal cord with split-pool barcoding no isolation of single cells needed!
-
Dynamics and Spatial Genomics of the Nascent Transcriptome by Intron seqFISH
-
Highly Multiplexed Single-Cell RNA-seq for Defining Cell Population and Transcriptional Spaces blog post by Lior Patcher The benefits of multiplexing. Need to re-read carefully.
-
Three-dimensional intact-tissue sequencing of single-cell transcriptional states
-
Multi-omic profiling of transcriptome and DNA methylome in single nuclei with molecular partitioning
-
Linking transcriptome and chromatin accessibility in nanoliter droplets for single-cell sequencing
-
Simultaneous quantification of protein-DNA contacts and transcriptomes in single cells scDamID&T.
-
Self-reporting transposons enable simultaneous readout of gene expression and transcription factor binding in single cells piggyBac transposase.
- scBASE A set of tools for quantitation of allele-specific expression from scRNA-Seq data
- paper: Genomic encoding of transcriptional burst kinetics
-
Uncovering pseudotemporal trajectories with covariates from single cell and bulk expression data
-
all different algorithms https://github.com/agitter/single-cell-pseudotime
-
Genomic trajectories with heterogeneous genetic and environmental backgrounds
-
A descriptive marker gene approach to single-cell pseudotime inference
-
A collection of 50 trajectory inference methods within a common interface take a look of this!
-
velocyto RNA abundance is a powerful indicator of the state of individual cells, but does not directly reveal dynamic processes such as cellular differentiation. Here we show that RNA velocity - the time derivative of RNA abundance - can be estimated by distinguishing unspliced and spliced mRNAs in standard single-cell RNA sequencing protocols. paper comment
-
STREAM is an interactive computational pipeline for reconstructing complex celluar developmental trajectories from sc-qPCR, scRNA-seq or scATAC-seq data from Luca Pinello Lab.
- bigSCale: an analytical framework for big-scale single-cell data. github link for millions of cells (starts with a count matrix) bigScale2
- Alevin: An integrated method for dscRNA-seq quantification based on Salmon.
- How to Use Alevin with Seurat Alevin-Seurat Connection blog post
- Kallisto BUStools paper https://www.biorxiv.org/content/10.1101/673285v1
- SCope: Visualization of large-scale and high dimensional single cell data
- Scumi Summarizing single-cell RNA-sequencing data with unified molecular identifiers. scumi is a flexible Python package to process fastq files generated from different single-cell RNA-sequencing (scRNA-seq) protocols to produce a gene-cell sparse expression matrix for downstream analyses: CEL-Seq2, 10x Chromium, Drop-seq, Seq-Well, CEL-Seq2, inDrops, and SPLiT-seq
check this website for the tools being added:
https://www.scrna-tools.org/
paper published:
Exploring the single-cell RNA-seq analysis landscape with the scRNA-tools database
https://twitter.com/constantamateur/status/994832241107849216?s=11
Did you know that droplet based single cell RNA-seq data (like 10X) is contaminated by ambient mRNAs? Good news though, we've written a paper (https://www.biorxiv.org/content/early/2018/04/20/303727 …) and created an R package called SoupX (https://github.com/constantAmateur/SoupX) to fix this problem.
Is this really a problem? It depends on your experiment. Contamination ranges from 2% - 50%. 10% seems common; it's 8% for 10X PBMC data. Solid tissues are typically worse, but there's no way to know in advance. Wouldn't you like to know how contaminated your data are?
These mRNAs come from the single cell suspension fed into the droplet creation system. They mostly get their from lysed cells and so resemble the cells being studied. This means the profile of the contamination is experiment specific and creates a batch effect.
cellranger is the toolkit developed by the 10x genomics company to deal with the data.
DropletUtils Provides a number of utility functions for handling single-cell (RNA-seq) data from droplet technologies such as 10X Genomics. This includes data loading, identification of cells from empty droplets, removal of barcode-swapped pseudo-cells, and downsampling of the count matrix.