PAGA: Graph Abstraction Reconciles Clustering with Trajectory Inference Through a Topology Preserving Map of Single Cells F

Total Page:16

File Type:pdf, Size:1020Kb

PAGA: Graph Abstraction Reconciles Clustering with Trajectory Inference Through a Topology Preserving Map of Single Cells F Wolf et al. Genome Biology (2019) 20:59 https://doi.org/10.1186/s13059-019-1663-x METHOD Open Access PAGA: graph abstraction reconciles clustering with trajectory inference through a topology preserving map of single cells F. Alexander Wolf1 , Fiona K. Hamey2, Mireya Plass3, Jordi Solana3,JoakimS.Dahlin2,4, Berthold Göttgens2, Nikolaus Rajewsky3, Lukas Simon1 and Fabian J. Theis1,5* Abstract Single-cell RNA-seq quantifies biological heterogeneity across both discrete cell types and continuous cell transitions. Partition-based graph abstraction (PAGA) provides an interpretable graph-like map of the arising data manifold, based on estimating connectivity of manifold partitions (https://github.com/theislab/paga). PAGA maps preserve the global topology of data, allow analyzing data at different resolutions, and result in much higher computational efficiency of the typical exploratory data analysis workflow. We demonstrate the method by inferring structure-rich cell maps with consistent topology across four hematopoietic datasets, adult planaria and the zebrafish embryo and benchmark computational performance on one million neurons. Background and processes such as development, dose response, and Single-cell RNA-seq offers unparalleled opportunities for disease progression. Here, we unify both viewpoints. comprehensive molecular profiling of thousands of indi- A central example of dissecting heterogeneity in single- vidual cells, with expected major impacts across a broad cell experiments concerns data that originate from com- range of biomedical research. The resulting datasets are plex cell differentiation processes. However, analyzing often discussed using the term transcriptional landscape. such data using pseudotemporal ordering [2, 5–9]faces However, the algorithmic analysis of cellular hetero- the problem that biological processes are usually incom- geneity and patterns across such landscapes still faces pletely sampled. As a consequence, experimental data do fundamental challenges, for instance, in how to explain not conform with a connected manifold and the mod- cell-to-cell variation. Current computational approaches eling of data as a continuous tree structure, which is attempt to achieve this usually in one of two ways [1]. the basis for existing algorithms, has little meaning. This Clustering assumes that data is composed of biologically problem exists even in clustering-based algorithms for distinct groups such as discrete cell types or states and the inference of tree-like processes [10–12], which make labels these with a discrete variable—the cluster index. By the generally invalid assumption that clusters conform contrast, inferring pseudotemporal orderings or trajecto- with a connected tree-like topology. Moreover, they rely ries of cells [2–4] assumes that data lie on a connected on feature-space based inter-cluster distances, like the manifold and labels cells with a continuous variable—the euclidean distance of cluster means. However, such dis- distance along the manifold. While the former approach tance measures quantify biological similarity of cells only is the basis for most analyses of single-cell data, the latter at a local scale and are fraught with problems when used enables a better interpretation of continuous phenotypes for larger-scale objects like clusters. Efforts for addressing the resulting high non-robustness of tree-fitting to dis- *Correspondence: [email protected] tances between clusters [10]bysampling[11, 12]have 1Helmholtz Center Munich – German Research Center for Environmental only had limited success. Health, Institute of Computational Biology, Neuherberg, Munich, Germany 5Department of Mathematics, Technische Universität München, Munich, Partition-based graph abstraction (PAGA) resolves Germany these fundamental problems by generating graph-like 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. Wolf et al. Genome Biology (2019) 20:59 Page 2 of 9 maps of cells that preserve both continuous and discon- node in V corresponds to a cell and each edge in E nected structure in data at multiple resolutions. The data- represents a neighborhood relation (Fig. 1)[3, 15–17]. driven formulation of PAGA allows to robustly recon- However, the complexity of G and noise-related spuri- struct branching gene expression changes across different ous edges make it both hard to trace a putative biological datasets and, for the first time, enabled reconstructing the process from progenitor cells to different fates and to lineage relations of a whole adult animal [13]. Further- decide whether groups of cells are in fact connected or more, we show that PAGA-initialized manifold learning disconnected. Moreover, tracing isolated paths of single algorithms converge faster, produce embeddings that are cells to make statements about a biological process comes more faithful to the global topology of high-dimensional with too little statistical power to achieve an acceptable data, and introduce an entropy-based measure for quan- confidence level. Gaining power by averaging over distri- tifying such faithfulness. Finally, we show how PAGA butions of single-cell paths is hampered by the difficulty abstracts transition graphs, for instance, from RNA veloc- of fitting realistic models for the distribution of these ity and compare to previous trajectory-inference algo- paths. rithms. With this, PAGA provides a graph abstraction We address these problems by developing a statis- method [14] that is suitable for deriving interpretable tical model for the connectivity of groups of cells, abstractions of the noisy kNN-like graphs that are typi- which we typically determine through graph-partitioning cally used to represent the manifolds arising in scRNA-seq [17–19] or alternatively through clustering or experi- data. mental annotation. This allows us to generate a simpler PAGA graph G∗ (Fig. 1) whose nodes correspond to cell Results groups and whose edge weights quantify the connec- PAGA maps discrete disconnected and continuous tivity between groups. Similar to modularity [20], the connected cell-to-cell variation statistical model considers groups as connected if their Both established manifold learning techniques and single- number of inter-edges exceeds a fraction of the number cell data analysis techniques represent data as a neigh- of inter-edges expected under random assignment. The borhood graph of single cells G = (V, E),whereeach connection strength can be interpreted as confidence in Fig. 1 Partition-based graph abstraction generates a topology-preserving map of single cells. High-dimensional gene expression data is represented as a kNN graph by choosing a suitable low-dimensional representation and an associated distance metric for computing neighborhood relations—in most of the paper, we use PCA-based representations and Euclidean distance. The kNN graph is partitioned at a desired resolution where partitions represent groups of connected cells. For this, we usually use the Louvain algorithm, however, partitions can be obtained in any other way, too. A PAGA graph is obtained by associating a node with each partition and connecting each node by weighted edges that represent a statistical measure of connectivity between partitions, which we introduce in the present paper. By discarding spurious edges with low weights, PAGA graphs reveal the denoised topology of the data at a chosen resolution and reveal its connected and disconnected regions. Combining high-confidence paths in the PAGA graph with a random-walk-based distance measure on the single-cell graph, we order cells within each partition according to their distance from a root cell. A PAGA path then averages all single-cell paths that pass through the corresponding groups of cells. This allows to trace gene expression changes along complex trajectories at single-cell resolution Wolf et al. Genome Biology (2019) 20:59 Page 3 of 9 the presence of an actual connection and allows discard- Box 1. Taking a classification view on embedding algo- ing spurious, noise-related connections (Additional file 1: rithms, we quantify how faithful an embedding is to the Note 1). While G represents the connectivity structure global topology of the high-dimensional data by com- of the data at single-cell resolution, the PAGA graph G∗ paring the distributions P and Q of edges in the high- represents the connectivity structure of the data at the dimensional and embedding spaces using a weighted chosen coarser resolution of the partitioning and allows to Kullback-Leibler divergence identify connected and disconnected regions of the data. ( || ) = disc( || ) + overl( || ) KLgeo P Q KLgeo P Q KLgeo P Q Following paths along nodes in G∗ means following an q p − ensemble of single-cell paths that pass through the cor- = de pe + de ( − ) 1 pe p pe log q 1 pe log − , ∈ de qe de 1 qe responding cell groups in G. By averaging over such an e Efc
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]