Accuracy, Robustness and Scalability of Dimensionality Reduction Methods for Single-Cell RNA-Seq Analysis Shiquan Sun1,2, Jiaqiang Zhu2, Ying Ma2 and Xiang Zhou2,3*

Total Page:16

File Type:pdf, Size:1020Kb

Accuracy, Robustness and Scalability of Dimensionality Reduction Methods for Single-Cell RNA-Seq Analysis Shiquan Sun1,2, Jiaqiang Zhu2, Ying Ma2 and Xiang Zhou2,3* Sun et al. Genome Biology (2019) 20:269 https://doi.org/10.1186/s13059-019-1898-6 RESEARCH Open Access Accuracy, robustness and scalability of dimensionality reduction methods for single-cell RNA-seq analysis Shiquan Sun1,2, Jiaqiang Zhu2, Ying Ma2 and Xiang Zhou2,3* Abstract Background: Dimensionality reduction is an indispensable analytic component for many areas of single-cell RNA sequencing (scRNA-seq) data analysis. Proper dimensionality reduction can allow for effective noise removal and facilitate many downstream analyses that include cell clustering and lineage reconstruction. Unfortunately, despite the critical importance of dimensionality reduction in scRNA-seq analysis and the vast number of dimensionality reduction methods developed for scRNA-seq studies, few comprehensive comparison studies have been performed to evaluate the effectiveness of different dimensionality reduction methods in scRNA-seq. Results: We aim to fill this critical knowledge gap by providing a comparative evaluation of a variety of commonly used dimensionality reduction methods for scRNA-seq studies. Specifically, we compare 18 different dimensionality reduction methods on 30 publicly available scRNA-seq datasets that cover a range of sequencing techniques and sample sizes. We evaluate the performance of different dimensionality reduction methods for neighborhood preserving in terms of their ability to recover features of the original expression matrix, and for cell clustering and lineage reconstruction in terms of their accuracy and robustness. We also evaluate the computational scalability of different dimensionality reduction methods by recording their computational cost. Conclusions: Based on the comprehensive evaluation results, we provide important guidelines for choosing dimensionality reduction methods for scRNA-seq data analysis. We also provide all analysis scripts used in the present study at www.xzlab.org/reproduce.html. Introduction are also paired with an excessive number of zeros known as Single-cell RNA sequencing (scRNA-seq) is a rapidly grow- dropouts [9]. Subsequently, dimensionality reduction ing and widely applying technology [1–3]. By measuring methods that transform the original high-dimensional noisy gene expression at a single-cell level, scRNA-seq provides expression matrix into a low-dimensional subspace with an unprecedented opportunity to investigate the cellular enriched signals become an important data processing step heterogeneity of complex tissues [4–8]. However, despite for scRNA-seq analysis [10]. Proper dimensionality reduc- the popularity of scRNA-seq, analyzing scRNA-seq data re- tion can allow for effective noise removal, facilitate data mains a challenging task. Specifically, due to the low cap- visualization, and enable efficient and effective downstream ture efficiency and low sequencing depth per cell in analysis of scRNA-seq [11]. scRNA-seq data, gene expression measurements obtained Dimensionality reduction is indispensable for many from scRNA-seq are noisy: collected scRNA-seq gene mea- types of scRNA-seq analysis. Because of the importance surements are often in the form of low expression counts, of dimensionality reduction in scRNA-seq analysis, many and in studies not based on unique molecular identifiers, dimensionality reduction methods have been developed and are routinely used in scRNA-seq software tools that * Correspondence: [email protected] include, but not limited to, cell clustering tools [12, 13] 2Department of Biostatistics, University of Michigan, Ann Arbor, MI 48109, USA and lineage reconstruction tools [14]. Indeed, most com- 3Center for Statistical Genetics, University of Michigan, Ann Arbor, MI 48109, monly used scRNA-seq clustering methods rely on USA dimensionality reduction as the first analytic step [15]. Full list of author information is available at the end of the article © The Author(s). 2019 Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated. Sun et al. Genome Biology (2019) 20:269 Page 2 of 21 For example, Seurat applies clustering algorithms dir- Unfortunately, despite the popularity of scRNA-seq ectly on a low-dimensional space inferred from principal technique, the critical importance of dimensionality re- component analysis (PCA) [16]. CIDR improves cluster- duction in scRNA-seq analysis, and the vast number of ing by improving PCA through imputation [17]. SC3 dimensionality reduction methods developed for scRNA- combines different ways of PCA for consensus clustering seq studies, few comprehensive comparison studies have [18]. Besides PCA, other dimensionality reduction tech- been performed to evaluate the effectiveness of different niques are also commonly used for cell clustering. For dimensionality reduction methods for practical applica- example, nonnegative matrix factorization (NMF) is used tions. Here, we aim to fill this critical knowledge gap by in SOUP [19]. Partial least squares is used in scPLS [20]. providing a comprehensive comparative evaluation of a Diffusion map is used in destiny [21]. Multidimensional variety of commonly used dimensionality reduction scaling (MDS) is used in ascend [22]. Variational infer- methods for scRNA-seq studies. Specifically, we com- ence autoencoder is used in scVI [23]. In addition to cell pared 18 different dimensionality reduction methods on clustering, most cell lineage reconstruction and develop- 30 publicly available scRNA-seq data sets that cover a mental trajectory inference algorithms also rely on di- range of sequencing techniques and sample sizes [12, 14, mensionality reduction [14]. For example, TSCAN 41]. We evaluated the performance of different dimen- builds cell lineages using minimum spanning tree based sionality reduction methods for neighborhood preserving on a low-dimensional PCA space [24]. Waterfall per- in terms of their ability to recover features of the original forms k-means clustering in the PCA space to eventually expression matrix, and for cell clustering and lineage re- produce linear trajectories [25]. SLICER uses locally lin- construction in terms of their accuracy and robustness ear embedding (LLE) to project the set of cells into a using different metrics. We also evaluated the computa- lower-dimension space for reconstructing complex cellu- tional scalability of different dimensionality reduction lar trajectories [26]. Monocle employs either independ- methods by recording their computational time. To- ent components analysis (ICA) or uniform manifold gether, we hope our results can serve as an important approximation and projection (UMAP) for dimensional- guideline for practitioners to choose dimensionality re- ity reduction before building the trajectory [27, 28]. duction methods in the field of scRNA-seq analysis. Wishbone combines PCA and diffusion maps to allow for bifurcation trajectories [29]. Results Besides the generic dimensionality reduction methods We evaluated the performance of 18 dimensionality re- mentioned in the above paragraph, many dimensionality duction methods (Table 1; Additional file 1: Figure S1) reduction methods have also been developed recently on 30 publicly available scRNA-seq data sets (Add- that are specifically targeted for modeling scRNA-seq itional file 1: Table S1-S2) and 2 simulated data sets. De- data. These scRNA-seq-specific dimensionality reduction tails of these data sets are provided in “Methods and methods can account for either the count nature of Materials.” Briefly, these data sets cover a wide variety of scRNA-seq data and/or the dropout events commonly sequencing techniques that include Smart-Seq2 [1](8 encountered in scRNA-seq studies. For example, ZIFA data sets), Smart-Seq [53] (5 data sets), 10X Genomics relies on a zero-inflation normal model to model drop- [33] (6 data sets), inDrop [54] (1 data set), RamDA-seq out events [30]. pCMF models both dropout events and [55] (1 data set), sci-RNA-seq3 [28] (1 data set), SMAR- the mean-variance dependence resulting from the count Ter [56] (5 data sets), and others [57] (3 data sets). In nature of scRNA-seq data [31]. ZINB-WaVE incorpo- addition, these data sets cover a range of sample sizes rates additional gene-level and sample-level covariates from a couple of hundred cells to over tens of thousands for more accurate dimensionality reduction [32]. Finally, of cells. In each data set, we evaluated the ability of dif- several deep learning-based dimensionality reduction ferent dimensionality reduction methods in preserving methods have recently been developed to enable scalable the original feature of the expression matrix, and, more and effective computation in large-scale scRNA-seq data, importantly, their effectiveness for two important single- including data that are collected by 10X Genomics tech- cell analytic tasks: cell clustering and lineage inference. niques [33] and/or from large consortium studies such In particular, we used 14 real data sets together with 2 as Human Cell Atlas (HCA) [34, 35]. Common deep simulated data sets for dimensionality
Recommended publications
  • A Cluster Specific Latent Dirichlet Allocation Model for Trajectory Clustering in Crowded Videos
    A CLUSTER SPECIFIC LATENT DIRICHLET ALLOCATION MODEL FOR TRAJECTORY CLUSTERING IN CROWDED VIDEOS ∗ Jialing Zou, Yanting Cui, Fang Wan, Qixiang Ye, Jianbin Jiao University of Chinese Academy of Sciences, Beijing 101408, China. ∗ [email protected] ABSTRACT Trajectory analysis in crowded video scenes is challeng- ing as trajectories obtained by existing tracking algorithms are often fragmented. In this paper, we propose a new approach to do trajectory inference and clustering on fragmented tra- jectories, by exploring a cluster specif c Latent Dirichlet Al- location(CLDA) model. LDA models are widely used to learn middle level trajectory features and perform trajectory infer- ence. However, they often require scene priors in the learn- ing or inference process. Our cluster specif c LDA model ad- dresses this issue by using manifold based clustering as ini- tialization and iterative statistical inference as optimization. The output middle level features of CLDA are input to a clus- (a) (b) tering algorithm to obtain trajectory clusters. Experiments on Fig. 1. (a) Illustration of the LDA based topic extraction in a public dataset show the effectiveness of our approach. original feature space (up) and a manifold embedding space Index Terms— Latent Dirichlet Allocation, Manifold, (down). (b) Illustration of correspondence between trajectory Trajectory clustering clusters and the manifold embedding. 1. INTRODUCTION [6], Wang et al. propose two Euclidean similarity measures, and perform trajectories with the def ned measures. In [7], Trajectory clustering is a video analysis task whose goal is Hu et al. introduce a dimensional spectral clustering method. to assign individual trajectories with common cluster labels, Trajectories are projected to a lower space through eigenvalue with applications in activity surveillance, traff c f ow estima- factorization, and are clustered in the lower sub-space with a tion and emergency response [1], [2].
    [Show full text]
  • Alignment of Time-Course Single-Cell RNA-Seq Data with CAPITAL
    bioRxiv preprint doi: https://doi.org/10.1101/859751; this version posted November 29, 2019. The copyright holder for this preprint (which was not certified by peer review) is the author/funder. All rights reserved. No reuse allowed without permission. Alignment of time-course single-cell RNA-seq data with CAPITAL Reiichi Sugihara1, Yuki Kato1;,∗ Tomoya Mori2 and Yukio Kawahara1 1 Department of RNA Biology and Neuroscience, Graduate School of Medicine, Osaka University, 2-2 Yamada-oka, Suita, Osaka 565-0871, Japan 2 Bioinformatics Center, Institute for Chemical Research, Kyoto University, Gokasho, Uji, Kyoto 611-0011, Japan Abstract Recent techniques on single-cell RNA sequencing have boosted transcriptome-wide observa- tion of gene expression dynamics of time-course data at a single-cell scale. Typical examples of such analysis include inference of a pseudotime cell trajectory, and comparison of pseudotime trajectories between different experimental conditions will tell us how feature genes regulate a dy- namic cellular process. Existing methods for comparing pseudotime trajectories, however, force users to select trajectories to be compared because they can deal only with simple linear trajec- tories, leading to the possibility of making a biased interpretation. Here we present CAPITAL, a method for comparing pseudotime trajectories with tree alignment whereby trajectories including branching can be compared without any knowledge of paths to be compared. Computational tests on time-series public data indicate that CAPITAL can align non-linear pseudotime trajectories and reveal gene expression dynamics. 1 Introduction Single-cell RNA-sequencing (scRNA-seq) has enabled us to scrutinize gene expression of dynamic cellular processes such as differentiation, reprogramming and cell death.
    [Show full text]
  • Trajectory Inference Across Multiple Conditions with Condiments
    bioRxiv preprint doi: https://doi.org/10.1101/2021.03.09.433671; this version posted March 10, 2021. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY 4.0 International license. 1 Trajectory inference across multiple conditions with condiments: 2 differential topology, progression, differentiation, and expression 1;2 3;4 3 Hector Roux de B´ezieux , Koen Van den Berge , Kelly Street5;6;7;8, Sandrine Dudoit1;2;3;7;8 1 Division of Biostatistics, School of Public Health, University of California, Berkeley, CA, USA 2 Center for Computational Biology, University of California, Berkeley, CA, USA 3 Department of Statistics, University of California, Berkeley, CA, USA 4 Department of Applied Mathematics, Computer Science and Statistics, Ghent University, Ghent, Belgium 5 Department of Data Sciences, Dana-Farber Cancer Institute, Boston, MA, USA 6 Department of Biostatistics, Harvard T.H. Chan School of Public Health, Boston, MA, USA 7 These authors contributed equally. 8 To whom correspondence should be addressed: [email protected], [email protected] 4 March 9, 2021 5 Abstract 6 In single-cell RNA-sequencing (scRNA-seq), gene expression is assessed individually for each cell, 7 allowing the investigation of developmental processes, such as embryogenesis and cellular differenti- 8 ation and regeneration, at unprecedented resolutions. In such dynamic biological systems, grouping 9 cells into discrete groups is not reflective of the biology. Cellular states rather form a continuum, 10 e.g., for the differentiation of stem cells into mature cell types.
    [Show full text]
  • Inferring Cellular Trajectories from Scrna-Seq Using Pseudocell Tracer
    bioRxiv preprint doi: https://doi.org/10.1101/2020.06.26.173179; this version posted June 27, 2020. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY 4.0 International license. TITLE Inferring cellular trajectories from scRNA-seq using Pseudocell Tracer AUTHORS Derek Reiman1#, Heping Xu2,3# , Andrew Sonin4, Dianyu Chen2,3, Harinder Singh5* and Aly A. Khan4* AFFILIATIONS 1University of Illinois at Chicago, Department of Bioengineering, Chicago, IL, 2Key Laboratory of Growth Regulation and Translation Research of Zhejiang Province, School of Life Sciences, Westlake University, Hangzhou, Zhejiang Province, China, 3Institute of Biology, Westlake Institute for Advanced Study, Hangzhou, Zhejiang Province, China, 4University of Chicago, Department of Pathology, Chicago, IL, 5University of Pittsburgh, Center for Systems Immunology, Departments of Immunology and Computational and Systems Biology, Pittsburgh, PA #These authors contributed equally *Correspondence: [email protected]; [email protected] bioRxiv preprint doi: https://doi.org/10.1101/2020.06.26.173179; this version posted June 27, 2020. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY 4.0 International license. ABSTRACT Single cell RNA sequencing (scRNA-seq) can be used to infer a temporal ordering of dynamic cellular states. Current methods for the inference of cellular trajectories rely on unbiased dimensionality reduction techniques. However, such biologically agnostic ordering can prove difficult for modeling complex developmental or differentiation processes.
    [Show full text]
  • Cellrank for Directed Single-Cell Fate Mapping
    CellRank for directed single-cell fate mapping Fabian Theis ( [email protected] ) Helmholtz Zentrum München https://orcid.org/0000-0002-2419-1943 Marius Lange Institute of Computational Biology, Helmholtz Center Munich https://orcid.org/0000-0002-4846-1266 Volker Bergen Institute of Computational Biology, Helmholtz Center Munich Michal Klein Institute of Computational Biology, Helmholtz Center Munich Manu Setty Sloan Kettering Institute, Memorial Sloan Kettering Cancer Center Bernhard Reuter Department of Computer Science, University of Tübingen Mostafa Bakhti Institute of Diabetes and Regeneration Research, Helmholtz Center Munich, Heiko Lickert Helmholtz Zentrum München https://orcid.org/0000-0002-4597-8825 Meshal Ansari Institute of Computational Biology, Helmholtz Center Munich Janine Schniering Institute of Lung Biology and Disease (ILBD), Helmholtz Zentrum München Herbert Schiller Helmholtz Zentrum München, Institute of Lung Biology and Disease, Group Systems Medicine of Chronic Lung Disease, Member of the German Center for Lung Research (DZL), CPC-M bioArchive,Munich https://orcid.org/0000-0001-9498-7034 Dana Pe'er Memorial Sloan Kettering Cancer Center https://orcid.org/0000-0002-9259-8817 Article Keywords: CellRank, directed, single-cell fate mapping Posted Date: October 29th, 2020 DOI: https://doi.org/10.21203/rs.3.rs-94819/v1 License: This work is licensed under a Creative Commons Attribution 4.0 International License. Read Full License October 19, 2020 CellRank - Online Methods Marius Lange1,2, Volker Bergen1,2, Michal Klein1, Manu Setty3, Bernhard Reuter4,5, Mostafa Bakhti6,7, Heiko Lickert6,7, Meshal Ansari1,8, Janine Schniering8, Herbert B. Schiller8, Dana Pe’er3*, Fabian J. Theis1,2,9* 1 Institute of Computational Biology, Helmholtz Center Munich, Germany.
    [Show full text]
  • Single-Cell Trajectories Reconstruction, Exploration and Mapping of Omics Data with STREAM
    ARTICLE https://doi.org/10.1038/s41467-019-09670-4 OPEN Single-cell trajectories reconstruction, exploration and mapping of omics data with STREAM Huidong Chen 1,2,3,4, Luca Albergante 5,6,7, Jonathan Y. Hsu1,8, Caleb A. Lareau 1,9, Giosuè Lo Bosco 10,11, Jihong Guan4, Shuigeng Zhou12, Alexander N. Gorban 13,14, Daniel E. Bauer9,15, Martin J. Aryee 1,3,9, David M. Langenau1,16, Andrei Zinovyev 5,6,7,14, Jason D. Buenrostro 9,17, Guo-Cheng Yuan 2,3,16 & Luca Pinello 1,9 1234567890():,; Single-cell transcriptomic assays have enabled the de novo reconstruction of lineage differ- entiation trajectories, along with the characterization of cellular heterogeneity and state transitions. Several methods have been developed for reconstructing developmental trajec- tories from single-cell transcriptomic data, but efforts on analyzing single-cell epigenomic data and on trajectory visualization remain limited. Here we present STREAM, an interactive pipeline capable of disentangling and visualizing complex branching trajectories from both single-cell transcriptomic and epigenomic data. We have tested STREAM on several syn- thetic and real datasets generated with different single-cell technologies. We further demonstrate its utility for understanding myoblast differentiation and disentangling known heterogeneity in hematopoiesis for different organisms. STREAM is an open-source software package. 1 Molecular Pathology Unit & Cancer Center, Massachusetts General Hospital Research Institute and Harvard Medical School, Boston, MA 02114, USA. 2 Department of Biostatistics and Computational Biology, Dana-Farber Cancer Institute, Boston, MA 02215, USA. 3 Department of Biostatistics, Harvard T.H. Chan School of Public Health, Boston, MA 02215, USA.
    [Show full text]
  • Statistical Analysis for Scrnaseq Data
    Statistical analysis for scRNAseq data Cathy Maugis-Rabusseau [email protected] C.Maugis-Rabusseau (IMT/INSA) Statistical analysis for scRNAseq data 1 / 52 Plan 1 Introduction 2 Feature selection / extraction 3 Dimension reduction 4 Single cell clustering 5 Pseudotime analysis 6 Differential analysis C.Maugis-Rabusseau (IMT/INSA) Statistical analysis for scRNAseq data 2 / 52 scRNA-seq data n cells, G genes: n ≤ G or n ≈ G =) high dimensionality Measures: xij = expression of the gene j for the cell i 2 N Technical and biological noise High variability Zero-inflated data =) "sparsity" (≥ 80% of zeros per raw, dropouts) C.Maugis-Rabusseau (IMT/INSA) Statistical analysis for scRNAseq data 3 / 52 Biological questions Are there distinct subpopulations of cells? For each cell type, what are the marker genes? How visualize the cells? Are there continuums of differentiation / activation cell states? ... Rostom et al, FEBS 2017 C.Maugis-Rabusseau (IMT/INSA) Statistical analysis for scRNAseq data 4 / 52 Statistical analysis Clustering of cells Variable (gene) selection in learning or differential analysis (hypothesis testing) Reduction dimension Network inference ... Rostom et al, FEBS 2017 C.Maugis-Rabusseau (IMT/INSA) Statistical analysis for scRNAseq data 5 / 52 Some bio-info-stat. pipelines/workflows [Juliá et al., 2015] Sincell (Bioconductor/R package) https://bioconductor.org/packages/release/bioc/html/sincell.html C.Maugis-Rabusseau (IMT/INSA) Statistical analysis for scRNAseq data 6 / 52 Some bio-info-stat. pipelines/workflows [Juliá et al., 2015] Sincell (Bioconductor/R package) [Poirion et al., 2016] C.Maugis-Rabusseau (IMT/INSA) Statistical analysis for scRNAseq data 6 / 52 Some bio-info-stat.
    [Show full text]
  • Minimum Spanning Vs. Principal Trees for Structured Approximations of Multi-Dimensional Datasets
    entropy Article Minimum Spanning vs. Principal Trees for Structured Approximations of Multi-Dimensional Datasets Alexander Chervov 1,2,3,*, Jonathan Bac 1,2,3,4 and Andrei Zinovyev 1,2,3,5,* 1 Institut Curie, PSL Research University, F-75005 Paris, France; [email protected] 2 Institut national de la santé et de la recherche médicale, U900, F-75005 Paris, France 3 CBIO-Centre for Computational Biology, Mines ParisTech, PSL Research University, 75006 Paris, France 4 Centre de Recherches Interdisciplinaires, Université de Paris, F-75000 Paris, France 5 Lobachevsky University, 603000 Nizhny Novgorod, Russia * Correspondence: [email protected] or [email protected] (A.C.); [email protected] (A.Z.) Received: 16 October 2020; Accepted: 7 November 2020; Published: 11 November 2020 Abstract: Construction of graph-based approximations for multi-dimensional data point clouds is widely used in a variety of areas. Notable examples of applications of such approximators are cellular trajectory inference in single-cell data analysis, analysis of clinical trajectories from synchronic datasets, and skeletonization of images. Several methods have been proposed to construct such approximating graphs, with some based on computation of minimum spanning trees and some based on principal graphs generalizing principal curves. In this article we propose a methodology to compare and benchmark these two graph-based data approximation approaches, as well as to define their hyperparameters. The main idea is to avoid comparing graphs directly, but at first to induce clustering of the data point cloud from the graph approximation and, secondly, to use well-established methods to compare and score the data cloud partitioning induced by the graphs.
    [Show full text]
  • Trajectory Inference Analysis
    scRNAseq2021 Trajectory inference analysis Paulo Czarnewski, ELIXIR-Sweden (NBIS) Åsa Björklund, ELIXIR-Sweden (NBIS) European Life Sciences Infrastructure for Biological Information www.elixir-europe.org Why trajectory inference? Reads Read QC Raw counts Count QC Normalization The workflow is dataset-specific: • Research question PCA • Batches • Experimental Conditions • Sequencing method • … Clustering tSNE / UMAP (visualization) TRAJECTORY Diff. Expression What is trajectory inference / pseudotime? Developmental time (e.g. cell activation) 0h 1h 2h 3h 4h 5h 6h 7h 8h 9h Experimental time • Cells that differentiate display a continuous spectrum of states Transcriptional program for activation and differentiation • Individual cells will differentiate in an unsynchronized manner Each cell is a snapshot of differentiation time • Pseudotime – abstract unit of progress Distance between a cell and the start of the trajectory Should you run Trajectory Inference? Are you sure that you have a developmental trajectory? Do you have intermediate states? Do you believe that you have branching in your trajectory? Be aware, any dataset can be forced into a trajectory without any biological ! meaning! ! First make sure that gene set and dimensionality reduction captures what you expect. FAST development of Trajectory Inference Saelens et al (2018) BioRxiv Saelens et al (2019) Nat Biotechnology Trajectory Inference Overview Cannoodt et al (2016) Eur J Immunol ICA Independent Component Analysis A method for decomposing the data Why ICA? What we see in the data GeneA True biological signals GeneB Receptor Signaling GeneC Cell activation GeneD Cell proliferation GeneE Marker expression … Pseudotime Pseudotime ICA How does ICA work? PCA ICA 3 3 3 3 2 2 2 2 1 1 1 1 0 0 0 0 sample 2 sample 2 sample 2 sample 2 −1gene_B −1 −1gene_B −1 −2 −2 −2 −2 −3 −3 −3 −3 −3 −2 −1 0 1 2 3 −3 −2 −−13 −02 −11 20 31 2 3 −3 −2 −1 0 1 2 3 samplegene_A 1 sample 1 samplegene_A 1 sample 1 3 3 3 3 ICA assumes2 that: 2 2 2 1.
    [Show full text]
  • K-Nearest Neighbor Smoothing for High-Throughput Single-Cell
    bioRxiv preprint doi: https://doi.org/10.1101/217737; this version posted January 25, 2018. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY-NC 4.0 International license. 1 K-nearest neighbor smoothing for 2 high-throughput single-cell RNA-Seq data 1+ 1 1* 3 Florian Wagner , Yun Yan , and Itai Yanai 1 4 Institute for Computational Medicine, NYU School of Medicine, New York, NY, USA + 5 Email: fl[email protected] * 6 Email: [email protected] 7 ABSTRACT 8 High-throughput single-cell RNA-Seq (scRNA-Seq) methods can efficiently generate expression profiles 9 for thousands of cells, and promise to enable the comprehensive molecular characterization of all cell 10 types and states present in heterogeneous tissues. However, compared to bulk RNA-Seq, single-cell 11 expression profiles are extremely noisy and only capture a fraction of transcripts present in the cell. Here, 12 we propose an algorithm to smooth scRNA-Seq data, with the goal of significantly improving the signal-to- 13 noise ratio of each profile, while largely preserving biological expression heterogeneity. The algorithm is 14 based on the observation that across protocols, the technical noise exhibited by UMI-filtered scRNA-Seq 15 data closely follows Poisson statistics. Smoothing is performed by first identifying the nearest neighbors of 16 each cell in a step-wise fashion, based on variance-stabilized and partially smoothed expression profiles, 17 and then aggregating their transcript counts.
    [Show full text]
  • From Bivariate to Multivariate Analysis of Cytometric Data: Overview of Computational Methods and Their Application in Vaccination Studies
    Review From Bivariate to Multivariate Analysis of Cytometric Data: Overview of Computational Methods and Their Application in Vaccination Studies Simone Lucchesi 1, Simone Furini 2, Donata Medaglini 1 and Annalisa Ciabattini 1,* 1 Laboratory of Molecular Microbiology and Biotechnology (LA.M.M.B.), Department of Medical Biotechnologies, University of Siena, 53100 Siena, Italy; [email protected] (S.L.); [email protected] (D.M.) 2 Department of Medical Biotechnologies, University of Siena, 53100 Siena, Italy; [email protected] * Correspondence: [email protected] Received: 27 February 2020; Accepted: 18 March 2020; Published: 20 March 2020 Abstract: Flow and mass cytometry are used to quantify the expression of multiple extracellular or intracellular molecules on single cells, allowing the phenotypic and functional characterization of complex cell populations. Multiparametric flow cytometry is particularly suitable for deep analysis of immune responses after vaccination, as it allows to measure the frequency, the phenotype, and the functional features of antigen-specific cells. When many parameters are investigated simultaneously, it is not feasible to analyze all the possible bi-dimensional combinations of marker expression with classical manual analysis and the adoption of advanced automated tools to process and analyze high-dimensional data sets becomes necessary. In recent years, the development of many tools for the automated analysis of multiparametric cytometry data has been reported, with an increasing record of publications starting from 2014. However, the use of these tools has been preferentially restricted to bioinformaticians, while few of them are routinely employed by the biomedical community. Filling the gap between algorithms developers and final users is fundamental for exploiting the advantages of computational tools in the analysis of cytometry data.
    [Show full text]
  • Accurate Denoising of Single-Cell RNA-Seq Data Using Unbiased Principal Component Analysis Florian Wagner1,2, Dalia Barkley1 & Itai Yanai1,3
    bioRxiv preprint doi: https://doi.org/10.1101/655365; this version posted June 17, 2019. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY 4.0 International license. Accurate denoising of single-cell RNA-Seq data using unbiased principal component analysis Florian Wagner1,2, Dalia Barkley1 & Itai Yanai1,3 1 Institute for Computational Medicine, NYU School of Medicine, New York, USA 2 Email: [email protected] 3 Email: [email protected] Abstract Single-cell RNA-Seq measurements are commonly affected by high levels of technical noise, posing challenges for data analysis and visualization. A diverse array of methods has been proposed to computationally remove noise by sharing information across similar cells or genes, however their respective accuracies have been difficult to establish. Here, we propose a simple denoising strategy based on principal component analysis (PCA). We show that while PCA performed on raw data is biased towards highly expressed genes, this bias can be mitigated with a cell aggregation step, allowing the recovery of denoised expression values for both highly and lowly expressed genes. We benchmark our resulting ENHANCE algorithm and three previously described methods on simulated data that closely mimic real datasets, showing that ENHANCE provides the best overall denoising accuracy, recovering modules of co-expressed genes and cell subpopulations. Implementations of our algorithm are available at https://github.com/yanailab/enhance. Introduction Single-cell RNA-Seq (scRNA-Seq) enables the simultaneous measurement of the transcriptome across thousands of cells from complex tissues and entire organs1–5.
    [Show full text]