1
SC1: A Web-based Single Cell RNA-Seq Analysis Pipeline Marmar Moussa and Ion I. Mandoiu, CSE Department, University of Connecticut There are currently only a few software packages, mostly in R, available for single cell RNA-Seq (scRNA-seq) data analysis. Most of them require considerable programming knowledge and are not easy to use by biologists. Here, we present a web-based interactive scRNA-seq analysis pipeline publicly accessible at https://sc1.engr.uconn.edu. The SC1 workflow is implemented in the R programming language, with an interactive web-based front-end built using the Shiny framework. To facilitate interactive data exploration, time consuming computations such as computing PCA and t-SNE projections of the data following basic QC are performed in a preprocessing step. Preprocessed data is saved in the tool’s .scDat file format that can be uploaded for interactive analysis. The SC1 tool incorporates commonly used quality control (QC) options, including filtering cells based on number of detected genes, fraction of reads mapping to mitochondrial genes, ribosomal protein genes, or synthetic spike-ins. The analysis workflow also employs a novel method for gene selection based on Term-Frequency Inverse-Document-Frequency (TF-IDF) scores [1], and provides a broad range of methods for cell clustering, differential expression analysis, gene enrichment, visualization, and cell cycle analysis [3]. Correspondence: {marmar.moussa,ion}@uconn.edu Abstract Preprocessing and Imputation TF-IDF Based Gene Selection Interactive Visualization References 5: Monocytes, 6: Natural Killer 4: B cells 7,8: naïve cytotoxic, cytotoxic, activated cytotoxic 1: helper 2: regulatory Genes with highest avg. TF- IDF (highest mean GMM in red) Cell Clustering Quality Control Dashboard Dimensional reduction techniques include principal component analysis (PCA), a faster PCA version using randomized singular value decomposition, t-distributed Stochastic Neighborhood Embedding (t-SNE); and Uniform Manifold Approximation and Projection (UMAP). QC metrics include total UMI count, number of detected genes, ratio between the number of detected genes and total UMI count per cell, fraction of reads mapping to mitochondrial genes, and number of ribosomal protein genes detected. 1. Moussa, M., and Mandoiu, I.: Single Cell RNA-seq Data Clustering using TF-IDF based Methods. (BMC Genomics, 2018). 2. Moussa, M., Mandoiu, I.: LSImpute: Locality sensitive imputation for single- cell RNA-seq data. (Journal of Computational Biology, 2018). 3. Moussa, M. Computational cell cycle analysis of single cell RNA-seq data. 2018 IEEE 8th ICCABS. (2018). 4. Lukowski, S.W et al.: Detection of hpv e7 transcription at single-cell resolution in epidermis. Journal of Investigative Dermatology 138, (2018) 5. Gubin, M.M et al.: High-dimensional analysis delineates myeloid and lymphoid compartment remodeling during successful immune-checkpoint cancer therapy. Cell 175(4), 1014{1030 (2018) 6. Zheng, G.X et al.: Massively parallel digital transcriptional profiling of single cells. bioRxiv p. 065912 (2016) 7. Leng, N., Chu et al.: Oscope identifies oscillatory genes in unsynchronized single-cell rna-seq experiments. Nature methods 12(10), 947 (2015) 8. Li, C.L et al.: Somatosensory neuron types identified by high-coverage single- cell rna-sequencing and functional heterogeneity. Cell research 26(1),83 (2016) SC1 supports optional imputation using Locality Sensitive Imputation (LSImpute) [2], a novel imputation algorithm that iteratively selects cells with highest similarity level using locality sensitive hashing. The figures below show the Gene Detection Fraction (GDF) of an ultra-deep scRNA-Seq data of 209 somatosensory neurons from the mouse dorsal root ganglion [8] ( 31.5M mapped reads ; 10,950 +/-1,218 genes per cell) vs. a down-sampled version simulating drop- out effect at 200 K reads per cell. Term Frequency-Inverse Document Frequency (TF-IDF) for scRNA-Seq data is defined as × =( / ( (/ )) where x ij is the UMI count of gene i in cell j, n i is the number of cells expressing gene I, and N is the total number of cells. The above figure shows the TF-IDF based gene selection for the PBMCs from [6]. Genes that are highly expressed (high TF) and expressed in a small subset of cells (high IDF) contribute most to the segregation of the clusters. The genes with highest average TF-IDF score provide pre-clustering heterogeneity insights with as few as 50 top genes. = {| = ( ) |: = ,…, } In SC1CC approach, a PCA step is followed by performing a 3- dimensional t-SNE projection using the first few PCs to capture the local similarity of the cells without sacrificing global variation. Next, the cells, represented by their t-SNE coordinates, are clustered into a hierarchical structure (dendrogram) based on their cosine similarity. Finally, to generate an order of cells consistent to their position along the cell cycle, we reorder the leaves of the obtained dendrogram by using the Optimal Leaf Ordering (OLO) algorithm. We also propose a novel metric, referred to as Gene-Smoothness Score (GSS), based on serial correlation to assess the cells’ order: Cell Cycle Analysis Differential Expression Analysis Heat map and cell order and GSS scores ((a) and (b) below) for the clusters inferred by SC1CC on the αCTLA-4 dataset [5] (right). The ~200 cells in cluster 7 are further partitioned by SC1CC into 3 sub-clusters (c), all of which are marked as actively dividing based on GSS scores (d). Results for labeled hESC cell line from [7] (200+ single undifferentiated human embryonic stem cells isolated by FACS into 91, 80 and 76 cells in G1, S and G2/M). Differential expression (DE) analysis in SC1: One cluster vs. the rest (t-test using Welch approximation with 0.95 confidence interval) Selected clusters/groups DE analysis, volcano plots visualization of Log2FC vs. p-values for DE genes Genes enrichment analysis/cluster annotation: functional enrichment analysis performed using gProfiler for the differentially expressed genes per cluster, terms with highest enrichment scores visualized as word clouds SC1 visualizations include: Interactive 2D/3D visualizations of cell clusters, libraries, gene sets, and/or pairs of genes Volcano plots for differential expression Word clouds for gene enrichment analysis Violin plots showing probability density of gene expression values per cluster/library Heatmaps of log-transformed gene expression: Hierarchal clustering heatmaps Pseudo-bulk (summary) heatmaps Clustering algorithms include Hierarchical Agglomerative Clustering using Cosine distance applied to log2(x + 1) expression levels of most informative genes selected using top average TF-IDF scores. SC1 also provides Spherical K-means clustering using the top average TF-IDF genes as features and graph-based clustering using binarized TF- IDF data as described in [1]. The number of clusters can be specified by the user or automatically selected using gap statistics. In the above plot, Ward's Hierarchical Agglomerative Clustering using the top average TF-IDF genes was applied to the HPV data set from [4]. HPV data [4] HPV data [4] HPV data [4] PBMCs[6] PBMCs[6] PBMCs[6]

SC1: A Web-based Single Cell RNA-Seq Analysis Pipelineusing top average TF-IDF scores. SC1 also provides Spherical K-means clustering using the top averageTF-IDF genes as features

  • Upload
    others

  • View
    7

  • Download
    0

Embed Size (px)

Citation preview

Page 1: SC1: A Web-based Single Cell RNA-Seq Analysis Pipelineusing top average TF-IDF scores. SC1 also provides Spherical K-means clustering using the top averageTF-IDF genes as features

SC1: A Web-based Single Cell RNA-Seq Analysis Pipeline

Marmar Moussa and Ion I. Mandoiu, CSE Department, University of Connecticut

There are currently only a few software packages, mostly inR, available for single cell RNA-Seq (scRNA-seq) dataanalysis. Most of them require considerable programmingknowledge and are not easy to use by biologists. Here, wepresent a web-based interactive scRNA-seq analysis pipelinepublicly accessible at https://sc1.engr.uconn.edu.The SC1 workflow is implemented in the R programminglanguage, with an interactive web-based front-end builtusing the Shiny framework. To facilitate interactive dataexploration, time consuming computations such ascomputing PCA and t-SNE projections of the data followingbasic QC are performed in a preprocessing step.Preprocessed data is saved in the tool’s .scDat file formatthat can be uploaded for interactive analysis. The SC1 toolincorporates commonly used quality control (QC) options,including filtering cells based on number of detected genes,fraction of reads mapping to mitochondrial genes, ribosomalprotein genes, or synthetic spike-ins. The analysis workflowalso employs a novel method for gene selection based onTerm-Frequency Inverse-Document-Frequency (TF-IDF)scores [1], and provides a broad range of methods for cellclustering, differential expression analysis, gene enrichment,visualization, and cell cycle analysis [3].Correspondence: {marmar.moussa,ion}@uconn.edu

Abstract

Preprocessing and Imputation

TF-IDF Based Gene Selection

Interactive Visualization

References

5: Monocytes,6: Natural Killer4: B cells7,8: naïve cytotoxic, cytotoxic, activated cytotoxic1: helper2: regulatory

Genes with highest avg. TF-IDF (highest mean GMM in red)

Cell Clustering

Quality Control Dashboard

Dimensional reduction techniques include principalcomponent analysis (PCA), a faster PCA version usingrandomized singular value decomposition, t-distributedStochastic Neighborhood Embedding (t-SNE); and UniformManifold Approximation and Projection (UMAP).

QC metrics include total UMI count, number of detectedgenes, ratio between the number of detected genes andtotal UMI count per cell, fraction of reads mapping tomitochondrial genes, and number of ribosomal proteingenes detected.

1. Moussa, M., and Mandoiu, I.: Single Cell RNA-seq Data Clustering using TF-IDF based Methods. (BMC Genomics, 2018).2. Moussa, M., Mandoiu, I.: LSImpute: Locality sensitive imputation for single-cell RNA-seq data. (Journal of Computational Biology, 2018).3. Moussa, M. Computational cell cycle analysis of single cell RNA-seq data. 2018 IEEE 8th ICCABS. (2018).4. Lukowski, S.W et al.: Detection of hpv e7 transcription at single-cell resolution in epidermis. Journal of Investigative Dermatology 138, (2018)5. Gubin, M.M et al.: High-dimensional analysis delineates myeloid and lymphoid compartment remodeling during successful immune-checkpoint cancer therapy. Cell 175(4), 1014{1030 (2018)6. Zheng, G.X et al.: Massively parallel digital transcriptional profiling of single cells. bioRxiv p. 065912 (2016)7. Leng, N., Chu et al.: Oscope identifies oscillatory genes in unsynchronized single-cell rna-seq experiments. Nature methods 12(10), 947 (2015)8. Li, C.L et al.: Somatosensory neuron types identified by high-coverage single-cell rna-sequencing and functional heterogeneity. Cell research 26(1),83 (2016)

SC1 supports optional imputation using Locality SensitiveImputation (LSImpute) [2], a novel imputation algorithmthat iteratively selects cells with highest similarity level usinglocality sensitive hashing. The figures below show the GeneDetection Fraction (GDF) of an ultra-deep scRNA-Seq data of209 somatosensory neurons from the mouse dorsal rootganglion [8] (≈31.5M mapped reads ;≈10,950 +/-1,218genes per cell) vs. a down-sampled version simulating drop-out effect at 200 K reads per cell.

Term Frequency-Inverse Document Frequency (TF-IDF) for scRNA-Seq data is defined as𝑻𝑻𝑭𝑭𝒊𝒊𝒊𝒊 × 𝑰𝑰𝑰𝑰𝑭𝑭𝒊𝒊 = (𝒙𝒙𝒊𝒊𝒊𝒊/𝒎𝒎𝒎𝒎𝒙𝒙𝒌𝒌 𝒙𝒙𝒌𝒌𝒊𝒊) × (𝒍𝒍𝒍𝒍𝒍𝒍𝟐𝟐(𝑵𝑵/𝒏𝒏𝒊𝒊))

where xij is the UMI count of gene i in cell j, ni is the number of cells expressing gene I,and N is the total number of cells. The above figure shows the TF-IDF based geneselection for the PBMCs from [6]. Genes that are highly expressed (high TF) andexpressed in a small subset of cells (high IDF) contribute most to the segregation of theclusters. The genes with highest average TF-IDF score provide pre-clusteringheterogeneity insights with as few as 50 top genes.

𝑮𝑮𝑮𝑮𝑮𝑮 𝒄𝒄 = 𝑴𝑴𝑴𝑴𝑴𝑴𝒊𝒊𝒎𝒎𝒏𝒏{|𝑮𝑮𝑪𝑪𝒍𝒍𝒐𝒐𝑴𝑴 𝒍𝒍𝒊𝒊 −𝟏𝟏𝑹𝑹�𝒊𝒊=𝟏𝟏

𝑹𝑹

𝑮𝑮𝑪𝑪𝒐𝒐𝒎𝒎𝒏𝒏𝑴𝑴𝒊𝒊(𝒍𝒍𝒊𝒊) |: 𝒊𝒊 = 𝟏𝟏, … ,𝑵𝑵}

In SC1CC approach, a PCA step is followed by performing a 3-dimensional t-SNE projection using the first few PCs to capturethe local similarity of the cells without sacrificing globalvariation. Next, the cells, represented by their t-SNEcoordinates, are clustered into a hierarchical structure(dendrogram) based on their cosine similarity. Finally, togenerate an order of cells consistent to their position along thecell cycle, we reorder the leaves of the obtained dendrogram byusing the Optimal Leaf Ordering (OLO) algorithm. We alsopropose a novel metric, referred to as Gene-Smoothness Score(GSS), based on serial correlation to assess the cells’ order:

Cell Cycle Analysis

Differential Expression Analysis

Heat map and cell order andGSS scores ((a) and (b) below)for the clusters inferred bySC1CC on the αCTLA-4 dataset[5] (right). The ~200 cells incluster 7 are furtherpartitioned by SC1CC into 3sub-clusters (c), all of whichare marked as actively dividingbased on GSS scores (d).

Results for labeled hESCcell line from [7] (200+single undifferentiatedhuman embryonic stemcells isolated by FACS into91, 80 and 76 cells in G1,S and G2/M).

Differential expression (DE) analysis in SC1:• One cluster vs. the rest (t-test using

Welch approximation with 0.95 confidence interval)

• Selected clusters/groups DE analysis, volcano plots visualization of Log2FC vs. p-values for DE genes

• Genes enrichment analysis/cluster annotation: functional enrichment analysis performed using gProfiler for the differentially expressed genes per cluster, terms with highest enrichment scores visualized as word clouds

SC1 visualizations include: • Interactive 2D/3D visualizations of cell clusters,

libraries, gene sets, and/or pairs of genes• Volcano plots for differential expression • Word clouds for gene enrichment analysis• Violin plots showing probability density of gene

expression values per cluster/library• Heatmaps of log-transformed gene expression:

• Hierarchal clustering heatmaps• Pseudo-bulk (summary) heatmaps

Clustering algorithms include Hierarchical Agglomerative Clustering using Cosinedistance applied to log2(x + 1) expression levels of most informative genes selectedusing top average TF-IDF scores. SC1 also provides Spherical K-means clustering usingthe top average TF-IDF genes as features and graph-based clustering using binarized TF-IDF data as described in [1]. The number of clusters can be specified by the user orautomatically selected using gap statistics. In the above plot, Ward's HierarchicalAgglomerative Clustering using the top average TF-IDFgenes was applied to the HPV data set from [4].

HPV data [4]

HPV data [4]

HPV data [4]

PBMCs[6]

PBMCs[6]PBMCs[6]