A Cluster Specific Latent Dirichlet Allocation Model for Trajectory Clustering in Crowded Videos

Total Page:16

File Type:pdf, Size:1020Kb

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]. k-means algorithm. In straightforward trajectory clustering approaches, a set Middle level features can also be learned with hierarchical of features, i.e. coordinates, velocities and/or geometrical latent variable Bayesian models, such as latent Dirichilet al- shapes and scene specif c information, are extracted to rep- location (LDA) [8] models, which have been widely explored resent trajectories, and then unsupervised learning methods in classif cation and clustering tasks [9], [10], [11], [12], [13], are used to classify these features [1], [2], [3]. However, in [14]. These models are adopted from the natural language videos of crowded scenes, it is often diff cult to obtain com- processing and are well known as ”topic models”. With LDA plete trajectories with off-the-shelf tracking algorithms [4]. In related models, trajectories are treated as documents and ob- most cases, fragmented trajectories of different length are ob- servations of trajectories are treated as visual words. Learned tained, which are diff cult to be aligned and represented with topics correspond to the middle level features of trajectories. low level features. In [12], Li et al. proposed a theme model that poses class Recently, middle level feature based trajectory clustering supervision to LDA, and enables different classes have dif- approaches have attracted attentions. Middle level features ferent topics. In [13], Daniel et.al. proposed a labeled LDA are usually observed as dominant paths of moving object- that assigns each class a Dirichlet prior. In [11], Wang et al. s, which can bridge the fragmented trajectories in low level proposed a topic-supervision LDA (ts-LDA) which enables feature space with their clusters [5]. Trajectory middle level different classes share different topics. In [14] Wang et al. features can be learned with non-Bayesian approaches, for ex- proposed a semi-latent LDA, which enables both the latent ample, similarity clustering [6] or dimension reduction [7]. In labels and words are visible in the training process. In [10], 978-1-4799-5751-4/14/$31.00 ©2014 IEEE 2348 ICIP 2014 Wang et al. proposed a mixture of latent Dirichlet allocation Nj (LDA) models for trajectory clustering. In [9], Zhou et al. z x % j ji ji ! proposed a Random Field Topic (RFT) model for trajectory M M N (a) j clustering by integrating scene priors. "c c $ C Despite of the effectiveness of above LDA models, how- Nj ever, most of them [10, 11, 12, 13] ignore the distribution % z x C j ji ji ! % z of data, so they often require a complex parameter estimation M and variable inference procedure. Some of them [9] use scene (b) (c) priors to improve performance, but can only be used in situ- ations where priors are available. Some of them [10, 12] use Fig. 2. LDA and CLDA models. (a) Graphical representation cluster initialization to replace scene priors, however, to do a of LDA, (b) Graphical representation of CLDA, (c) Graphical good initialization in a high dimensionalfeature space is often representation of approximate distribution of CLDA. diff cult. We propose a cluster-specif c LDA (CLDA) model with cluster initialization in a manifold embedding space and it- nates and velocities of tracked objects are described in Section θ erative optimization with Bayesian inference. As shown in 3. The joint probability of the model is given by Eq.(1), the p(θ|c, α) = C Dir(θ|α )δ(c,j) Fig.1(a), the cluster initialization enables that our approach probability is changed to j=1 j , Dir • create topics (middle level features) that can ref ect data distri- where ( ) denotes the Dirichlet distribution based on pa- α Q bution and cluster information, effectively. After the iterative rameter j . p(x, z, θ, c|α, β, η) = p(c|η)p(θ|α, c)· optimization, the CLDA model creates discriminative topics M (1) for clustering without using any scene prior. Here, “discrimi- j=1 p(zj|θj )p(xj |zj , β). native” implies that different sets of trajectories have different Other terms are consistentQ with that in [8]. Similar to [12], clusters in the manifold space, as shown in Fig.1(b). we set the uniform distribution p(c) = 1/C. And then The remainder of the paper is organized as follows: The leave out the estimation of η. The label C is updated by CLDA model is described in Section 2. The trajectory clus- arg maxc p(x|c, α, β), where x denotes a set of words of a tering approach is presented in section 3. Experiments are trajectory. The posterior probability of x is in Eq. (2). presented in Section 4 and we conclude the paper in Section p(x|α, β, c) = p(θ|α, c) 5. M (2) p(zj|θj )p(xj |zj , β) dθ. j R zj We use the variationalQ breakingP algorithm in [8] to do variable 2. CLUSTER-SPECIFIC LATENT DIRICHLET inference and parameter estimation. Fig.2(c) is the graphical ALLOCATION representation of the approximate distribution of the CLDA. Therefore, we have This section presents the CLDA and the middle level feature log p(x|α, β, c) = L(γc, φc; αc, β)+ (topic) extraction with the CLDA parameter estimation. (3) KL(q(θ, z|γc, φc)||p(θ, z|x, αc, β)). We iteratively maximize the the term L(•) instead of 2.1. Latent Dirichlet Allocation (LDA) log p(x|α, β, c), which results in the minimum of difference between the distribution in Fig. 2(b) and Fig. 2(c). The To make the paper self-contained, we f rst review the LDA. details of computation can be seen in [8]. In Eq. (4) and Eq. Fig. 2(a) shows the graphical representation of LDA [8]. Four (5), we present two terms related to middle level features. important notations about LDA are corpus, document, topic K and word, which in our case correspond to path, trajectory, c c c topic and visual word, respectively. M is number of docu- φki ∝ β exp Ψ(γk) − Ψ( γk) (4) " k=1 # ments. Nj is the number of words of each trajectory j. θ c X βk ∝ Σ φk,ini (5) is assumed to follow a Dirichlet distribution with parameter i α. zji is a latent variable being assumed to follow a parame- where φc denotes the probability that the ith word belongs terized multinomial distribution Mult(θj). x denotes words. ki β is hyper-parameter, corresponding to the middle level fea- to the kth topic’s. Ψ(•) is a digamma function and ni is the tures. count of the ith word in the codebook. βk is the kth topic’s feature representation with respect to the codebook. 2.2. Cluster-specif c Dirichlet Allocation (CLDA) 3. TRAJECTORY CLUSTERING Fig.2(b) shows the graphical representation of CLDA. It can be seen that observed visual words (low level features) and la- In trajectory clustering, we f rst connect trajectory fragments bels are inputs of the CLDA. The visual words that are coordi- into trajectory trees and extract low level features, which are 978-1-4799-5751-4/14/$31.00 ©2014 IEEE 2349 ICIP 2014 embedded in a dimensional manifold space for initial trajec- Low Level Feature Middle Level Feature Trajectory Extraction Extraction Clustering KLT Tracking tory clustering. With initial cluster labels, the middle level Bag of Cluster & CLDA words Label features are extracted by the proposed CLDA for f ne trajec- Videos Tree Spanning tory clustering. The f owchart of the proposed approach is Initial clustering shown in Fig.3. K-means on manifold 3.1. Low-level Feature Extraction Fig. 3. Flowchart of the proposed trajectory clustering ap- Given a crowded video, we f rst use a KLT tracker [15] to cal- proach. culate trajectory segments and motion vectors of objects. A spanning tree algorithm [9] is used to uncover spatiotemporal will be input to the information entropy clustering algorith- relations among trajectory fragments and connect them into m [9], which computes potential information entropy of trees trajectory trees, on which visual words are extracted as low that a trajectory segment belongs to, and then determines the level features.
Recommended publications
  • 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]
  • Downloaded from the NCBI GEO Database (GEO ID: GSE145926), and the Pre-Processed Gene-Expression Data Are Available At
    G C A T T A C G G C A T genes Article Investigating Cellular Trajectories in the Severity of COVID-19 and Their Transcriptional Programs Using Machine Learning Approaches Hyun-Hwan Jeong 1,†, Johnathan Jia 1,2,†, Yulin Dai 1, Lukas M. Simon 1,3 and Zhongming Zhao 1,2,4,* 1 Center for Precision Health, School of Biomedical Informatics, The University of Texas Health Science Center at Houston, Houston, TX 77030, USA; [email protected] (H.-H.J.); [email protected](J.J.); [email protected] (Y.D.); [email protected] (L.M.S.) 2 MD Anderson Cancer Center UTHealth Graduate School of Biomedical Sciences, Houston, TX 77030, USA 3 Therapeutic Innovation Center, Baylor College of Medicine, Houston, TX 77030, USA 4 Human Genetics Center, School of Public Health, The University of Texas Health Science Center at Houston, Houston, TX 77030, USA * Correspondence: [email protected]; Tel.: +1-713-500-3631 † The first two authors should be regarded as joint first authors. Abstract: Single-cell RNA sequencing of the bronchoalveolar lavage fluid (BALF) samples from COVID-19 patients has enabled us to examine gene expression changes of human tissue in response to the SARS-CoV-2 virus infection. However, the underlying mechanisms of COVID-19 pathogenesis at single-cell resolution, its transcriptional drivers, and dynamics require further investigation. In this study, we applied machine learning algorithms to infer the trajectories of cellular changes and identify their transcriptional programs. Our study generated cellular trajectories that show the COVID-19 pathogenesis of healthy-to-moderate and healthy-to-severe on macrophages and T cells, and we observed more diverse trajectories in macrophages compared to T cells.
    [Show full text]