Abstract
Analysis of gene expression in single cells allows for decomposition of cellular states as low-dimensional latent spaces. However, the interpretation and validation of these spaces remains a challenge. Here we present scCoGAPS which defines latent spaces from a source scRNA-seq dataset, and projectR which evaluates these latent spaces in independent target datasets via transfer learning. Application to scRNA-Seq of developing mouse retina reveals intrinsic relationships across biological contexts and assays, while avoiding batch effects and other technical features. We compare the dimensions learned in this source dataset to adult mouse retina, a time-course of human retinal development, select scRNA-Seq datasets from developing brain, ATAC-Seq data, and a murine cell type atlas to identify shared biological features. These tools lay the groundwork for exploratory analysis of scRNA-seq data via latent space representations, enabling a shift in how we compare and identify cells beyond reliance on marker genes or ensemble molecular identity.
eTOC
We present tools and workflows for latent space exploration across datasets. scCoGAPS is an implementation of NNMF that is specifically suited for large, sparse scRNA-Seq datasets. ProjectR implements a transfer learning framework that rapidly projects new data into learned latent spaces. We demonstrate the utility of this approach for de novo annotation of new datasets, cross species analysis, linking genomic regulatory and transcriptional signatures, and exploration of features across a catalog of cell types.
Graphical Abstract

Introduction
The identity of an individual cell is determined by the combinatorial effects of diverse biological processes. Dimension reduction techniques deconvolve gene expression data into discrete latent spaces, which may correspond to biological and technical influences on the transcriptome (Brunet et al., 2004a; Cleary et al., 2017; Kossenkov et al., 2007; Stein-O’Brien et al., 2018; Wagner et al., 2016; Zhu et al., 2017). Latent space techniques are frequently used in the context of novel biological discovery from high dimensional genomics datasets. Discovery requires both evaluation of the accuracy of the learned latent space and interpretation of biological processes from the low dimensional representation. Both of these tasks are challenging if not entirely ineffective using standard analytical methods, requiring biological validation to provide a gold standard (Cleary et al., 2017; Kiselev et al., 2019; Stein-O’Brien et al., 2018). However, in many applications such a gold standard does not exist. Nonetheless, multiple datasets and measurement assays of the same biological system should reflect a similar set of biological processes. Furthermore, subsets of cellular features may further be preserved across experimental systems from related biological contexts. These properties can be utilized to improve selection, analysis, and interpretation of diverse biological systems by leveraging information learned from different data sources. Specifically, we propose that establishing the biological relevance of latent spaces requires a three-fold approach to (1) learn gene expression signatures associated with biological processes, (2) demonstrate their association with specific cellular features in the dataset from which they are inferred, and (3) test their robustness across related, but diverse biological contexts. These latent spaces are best learned from single cell measures instead of bulk measurements where learned latent spaces may reflect confounded features across cell types and states. The first two steps of this process are prevalent across single cell RNA-Seq (scRNA-seq) analyses, but the second often relies on heuristic analysis and expert curation (Zappia et al., 2018). Transfer learning approaches can be used to perform the last two steps, thereby enabling in silico validation, interpretation, and exploration across diverse types of modern high-throughput biological data.
The machine learning subdomain of transfer learning exploits the fact that if two datasets share common latent spaces, a feature mapping between the two can identify and characterize relationships between the data defined by individual latent spaces (Pan et al., 2008). In this framework, one dataset is the source in which the latent space representation is learned and another the target that is mapped into the latent spaces learned in the source. The distribution, domain, or feature space of the source and target data may differ (Pan et al., 2008; Torrey and Shavlik, 2009). Thus, transfer learning techniques are ideally suited to assess shared latent spaces from one or more sources. Once the robustness of a biological process is established across systems, these approaches can also be applied to use these learned latent spaces to enable exploration of process use across data platforms, modalities, and studies. The established conservation of specific biological processes across systems, such as common developmental pathways across tissues or organisms, can be further leveraged to enable cross-study validation. In this case, the low dimensional patterns learned from latent space techniques will be shared in samples with biologically meaningful relationships between datasets, while dataset-specific factors and technical artifacts across datasets will not. The challenge then arises in providing a computational tool to enable this in silico validation.
We have adapted a transfer learning approach for high-throughput genomic data analysis with two new methods, scCoGAPS and ProjectR. These tools provided a framework enabling the identification, evaluation, and exploration of latent space features in both source and target datasets. To demonstrate this workflow across a variety of contexts, we apply these tools to a time course scRNA-seq dataset from murine retina development and demonstrate recovery of meaningful representations of biological features within individual latent spaces. Application of scCoGAPS identified gene expression signatures of discrete cell types and biological processes associated with cell cycle regulation, neurogenesis, and cell fate specification. We empirically evaluate our transfer learning approach across a diverse collection of single cell datasets. In addition to performance assessment, these analyses also demonstrate a wide range of biological applications. We demonstrate how to classify learned cell types in a previously published adult retina scRNA-Seq dataset via ProjectR projection (Macosko et al., 2015). We further illustrate how transfer learning can be used to extract meaningful biological insights across experimental modalities and species by projecting a bulk RNA-Seq human retinal development time course (Hoshino et al., 2017)and a mouse bulk ATAC-Seq dataset, into the learned latent spaces from a developing mouse retina scRNA-Seq dataset. To highlight the ability of projected patterns to recover related biological processes and cell types across developmentally related systems, we compare pattern usage between the developing mouse retina and two independent data sets derived from the developing cortex (Nowakowski et al., 2017; Zhong et al., 2018) and another from the developing mouse midbrain (La Manno et al., 2016). Finally, to examine the power of pattern exploration via transfer learning, we identify shared cellular features across a large collection of single cells from an atlas of mouse tissues (Tabula Muris Consortium et al., 2018). In aggregate, these analyses highlight the diversity of potential applications for transfer learning approaches to rapidly identify and describe related components between a source dataset, in this case derived from the developing mouse retina, and a variety of independent data sources using learned latent spaces.
Using a collection of latent spaces, learned from a dataset of single cell gene expression estimates, we demonstrate the utility of a combined reduced dimensional representation and transfer learning approach to identify shared cellular attributes and biological processes across diverse data types in a manner that avoids the complications of normalization or sample alignment. Our approach is able to annotate latent spaces, and reveal novel parallels between different tissues, molecular features, and species. Our approach demonstrates that ProjectR can rapidly transfer annotations, classify cells, and identify the use of biological processes without a priori knowledge or annotation within the source dataset. While we focus this application on low dimensional factors learned with scCoGAPS, projectR generalizes as an exploratory analysis and biological interpretation method for other dimension reduction techniques that find latent spaces associated with continuous gene weights.
Results
Adaptive sparsity for learning factors from scRNA-Seq (scCoGAPS): Theory
ScCoGAPS is a non-negative matrix factorization (NMF) algorithm. NMF algorithms factor a data matrix into two related matrices containing gene weights, the Amplitude (A) matrix, and sample weights, the Pattern (P) matrix (Fig 1A). Each column of A or row of P defines a factor, and together these sets of factors define the latent spaces amongst genes and samples, respectively. Each sample-level relationship in a row of the pattern matrix is referred to as a pattern, and the corresponding gene weights as an amplitude. In NMF, the values of the elements in the A and P matrices are required to be greater than or equal to zero. This constraint simultaneously reflects the non-negative nature of gene expression data and enforces additivity of factors, generating solutions that are biologically intuitive (Lee and Seung, 1999). The concept of up- or down-regulation reflects a relative difference between two conditions that can, and often is, described by comparing non-negative gene weights between patterns.
Figure 1. Mathematical core of the scCoGAPS algorithm.
(A) scRNA-Seq data yields a data matrix that has each sample as a column and each observed gene expression value as a row. scCoGAPS decomposes the preprocessed data matrix into two related matrices. The rows of the amplitude matrix (A) quantify the sources of variation among the genes and the columns of the pattern matrix (P) quantify the sources of variation among the cells. The matrix product of A and P approximates the preprocessed input data matrix. The number of columns of A equals the number of rows in P, and represents the number of dimensions in the low-dimensional representation of the data. Theoretically, each column in the amplitude matrix and the corresponding row of the pattern matrix represents a distinct source of biological, experimental, or technical variation in each cell. The values in the column of the amplitude matrix then represent the relative weight of each gene and the values in the row of the pattern matrix its relative role in each cell. Adaptive sparsity is achieved by placing a Poisson prior on the shape parameter in the gamma distribution for each matrix element (αAi,j, αPi,j) and a fixed scale parameter for all matrix elements (λA and λP) in A and P, respectively. In expectation, smaller values of αi,j will result in smaller values of corresponding matrix element, and vice versa for larger values which will also have a decreased probability of being zero. (B) Each iteration of the Markov Chain Monte Carlo sampling employed in CoGAPS updates the atomic space, which corresponds to an update in matrix elements. (C) There are four possible update steps to the atomic domain that preserve both the prior distribution in (A) and detailed balance: 1) birth to add an atom, 2) death to remove of an atom, 3) moving an atom from one position to another, and 4) exchanging the mass of two atoms. During the update, the probability of selecting birth or death is selected based on the Poisson prior reinforcing the adaptive sparsity. All heatmaps are colored on a blue-yellow scale, where yellow indicates higher expression values and blue lower.
Bayesian NMF techniques can embed biological and technical structure in the data in prior distributions on the A and P matrices (Kossenkov et al., 2007; Ochs and Fertig, 2012). To accomplish this for bulk data, we previously developed the Bayesian NMF Coordinated Gene Activity in Pattern Sets (CoGAPS) method (Fertig et al., 2010). CoGAPS uses an atomic prior (Sibisi and Skilling, 1996; Skilling and Sibisi, 1996) to model three biological constraints: non-negativity reflective of pleiotropy, sparsity reflective of parsimony, and smoothness reflective of gene co-regulation and smooth dynamic transitions. The atomic prior in CoGAPS is unique in enforcing a sample- and gene-specific sparsity constraint, which we term “adaptive sparsity”. In the atomic prior, each element of the A and P matrices is either zero or follows a gamma distribution. Adaptive sparsity is achieved by placing a Poisson prior on the discrete shape parameter in the gamma distribution for each matrix element (αAi,j, αPi,j) and a fixed scale parameter for all matrix elements (λA and λP) in A and P, respectively. Smaller values of αi,j result in smaller values of the corresponding matrix elements, and vice versa for larger values. Thus, the sparsity constraint on values of latent factors will be relaxed in this model, constraining some matrix elements away from zero (Fig 1B). Adaptive sparsity can also model biological structure in the presence of the technical dropouts and true biological zeros in scRNA-Seq. To accommodate the additional sparsity of scRNA-Seq data, λA and λP are set as proportional to the mean of all non-zero values in the data. In contrast, λA and λP for bulk RNA-Seq data are set using the means of the entire data set. A normal prior on the data enables an empirical solution for the conditional distributions with this Gamma prior, enabling efficient Gibbs sampling with this sparsity constraint (STAR Methods). This also models smoothness by grouping closely related dimensions near each other via move and exchange steps that shift a single exponential between adjacent matrix elements (Fig 1C). In practice, these steps retains the global Poisson prior on shape and the gamma prior on matrix elements while altering the shape parameters between adjacent matrix elements to model smoothness.
Parallelization and data structures for cross-validation and efficiency: Theory
Bayesian NMF algorithms such as CoGAPS have substantial computing costs that limit their application to the large datasets generated as tissue atlases with scRNA-Seq data. As we describe in the STAR Methods, representing the gamma distribution as a sum of exponentials enables efficient Gibbs sampling. We couple this representation with new data structures for their storage and corresponding calculations that are more efficient than previous versions of CoGAPS, and greatly reduce the computational cost for scRNA-Seq analysis (Fig S1A).
We can leverage our hypothesis that latent spaces learned from scRNA-Seq data are reflective of relative gene use in biological processes to enhance the efficiency of Bayesian NMF methods. In this case, distinct subsets of cells sampled from the same condition will have similar factors in a latent space, similar to our previous observation of similar factors across distinct subsets of genes in bulk data (Stein-O’Brien et al., 2018). Inference with Bayesian NMF is parallelized for distinct subsets of cells in the input scRNA-seq data. We selected the ratio of cells in each set to enable inference of latent space factors in highly skewed distributions of samples as can occur with rare cell types. As a result, this approach is a semi-supervised method in which inference of gene weights in factors is unsupervised. Consensus factors are then created across the sets as described previously for random sets of genes (Stein-O’Brien et al., 2018). In addition to gaining efficiency, the factors estimated in parallel across subsets of cells can also be compared to enable cross-validation of the inferred latent spaces (Fig S1B).
Transfer learning via dimension reduction using projectR: Theory
In our model, known and latent factors of a biological system can be used to compare independent, biologically related datasets. This comparison is made by defining a function from the factors in one dataset and projecting an independent, biologically related target dataset into a lower dimensional space that is common to both. Projection is defined as a mapping or transformation of points from one space to another, often a lower-dimensional space. Mathematically, this can be described as a function φ(x)=y: RD↦ Rd s.t for d ≤ D, x ∈ RD, y ∈ Rd. The innovation of projectR is the use of a mapping function defined from the latent spaces in a source data set, which enables the transfer of associated cellular phenotypes, annotations, and other metadata to samples in the target dataset (Fig 2).
Figure 2. Theoretical core of the projectR algorithm.
(A) Graphical representation of projection implemented in projectR showing the relationship between the learned functions, or mappings, and the datasets being operated on. (B) Transfer learning approaches can be adapted to reveal a variety of insights into both source and target datasets. The type and directionality of knowledge transfer enabled via projectR can vary depending on the experimental question and available annotation for each dataset. (C) Diagram of the pipeline used to first learn latent spaces and then project them to transfer learning as describe.
We propose that projection of well-defined latent spaces should capture shared biology across independent datasets. In this study, we perform projection in the column space defined by the amplitude matrix from scCoGAPS (factors representing gene weights). This is accomplished by estimating the patterns P associated with the amplitude matrix by a generalized least-squares fit to the target data (Fertig et al., 2013a) (STAR Methods). We select this projection approach as a computationally efficient method. Moreover, the lack of the orthogonality constraint allows for greater application of the transfer learning approach to non-orthogonal latent spaces, allowing for greater independence of factor projections. Assuming that a given dimension is associated with a specific cellular attribute in the target dataset, the magnitude of the value in this source dataset can indicate its presence within the target dataset. Inversely, if the cellular feature is not shared across the datasets, then projection of the target data into the given latent space will have no significant value. The significance of each projected pattern can be calculated using a Wald test for each sample:latent space interaction. Depending on the distribution or number of the projected sample weights, statistical comparisons between annotated groups can be performed to quantify the presence of these inferred processes in the target data. For example, the mean projected pattern weight between two groups can be compared using standard t-tests or regression-based contrasts. Additionally, classifiers can be built using the projected pattern weights, and the predictive value of each pattern assessed globally. This information transfer enables rapid and highly scalable comparison of very different datasets through the lens of a projected latent space learned in a reference dataset. This analysis can leverage the massive amount of publicly available data and their associated metadata to annotate phenotypes in source data more efficiently. Further, the ability to evaluate whether the processes described by latent spaces are shared, despite significant overall differences in the original high dimensional datasets, can enable hypothesis generation and integrated analyses.
Applications
Assessing latent spaces and dimensionality: lessons from bulk RNA-Seq
The developing mammalian retina provides an ideal model system to evaluate the degree to which latent spaces reflect known developmental biology. Features such as discrete cell type signatures, continuous state transitions, signaling pathway usage, developmental age, and sex should each be represented in independent latent spaces. An open question in retinal development is how progenitor cells can generate specific subtypes of neuronal and glial cell types during specific intervals during development—a phenomenon known as progenitor competence (Bassett and Wallace, 2012; Javed and Cayouette, 2017). In an effort to identify genes associated with changes in retinal progenitor cell (RPC) competence, we performed bulk RNA-Seq analysis on replicate populations of FACS-isolated RPCs and post-mitotic cells, which were isolated using the Chx10:GFP reporter (Rowan and Cepko, 2004), and assessed the fidelity of patterns learned in this bulk analysis across other experimental contexts.
FACS-sorted Chx10:GFP+ RPCs and Chx10:GFP- post-mitotic retinal neurons (Rowan and Cepko, 2004) were collected from the developing mouse retina at three time points, Embryonic day 14 (E14), Embryonic day (E18), Postnatal day 2 (P2), and subjected to standard bulk RNA sequencing (Zibetti et al., 2017). We applied our previous genome wide GWCoGAPS pipeline for bulk RNA-Seq to the normalized FPKM gene expression estimates to identify a latent space consisting of 10 patterns of co-regulated genes (Stein-O’Brien et al., 2017). Dimensionality can be optimized by maximizing the robustness of patterns between dimensions (Moloshok et al., 2002). Moreover, hierarchies of cell types or subtypes can be resolved by comparing patterns across dimensions (Fertig et al., 2013a). Therefore, we applied GWCoGAPS to the bulk data using a range of dimensionalizations to identify patterns associated with specific biological features or cellular states. Final dimensionality was assessed by comparing factorizations of different dimensions using the ClutrFree (Bidaut and Ochs, 2004) algorithm (STAR Methods). Patterns were strongly correlated (r2>0.7) between factorizations at different dimensions, indicating the overall robustness of the factors across dimensions (Fig S1C). For example, a pattern broadly associated with all retinal neurons at a lower dimensionality split into two patterns describing photoreceptors and inner retinal cells at a higher dimensionality, as assessed by correlation of cell type specific marker gene expression with individual patterns.
We next evaluated whether patterns identified from bulk RNA-Seq could describe discrete cell type signatures obtained from a comprehensive scRNA-Seq dataset conducted across retinal development (Clark et al., 2019). In this study, we isolated 120,804 individual cells from whole mouse retina at 10 developmental time points, ranging from embryonic day 11 (E11) to postnatal day 14 (P14). scRNA-Seq gene expression profiles were obtained using the 10x Genomics Chromium platform (Clark et al., 2019). To relate the data sets, the scRNA-Seq data was projected into the factors learned from the bulk RNA-Seq (Table S1) using projectR (STAR Methods). Using the expert- curated cell type annotations for each single cell, a random forest classifier was trained using projected sample weights as features. Sensitivity and specificity scores were calculated for the relationship between each bulk factor and the annotated cell types detected using scRNA-Seq.
While few patterns had high AUC values for specific cell types, most had moderate values spread across multiple lineages (Fig S1D). One potential explanation for this is that features shared across multiple cells types might dominate the latent spaces found at lower dimensionalization. This finding is consistent with observation that highly expressed genes tend to dominate differential expression analysis in bulk RNA-Seq (Ching et al., 2014). An alternative hypothesis is that latent spaces learned in aggregate bulk measures may not cleanly define discrete cell types or states. As bulk RNA-Seq is inherently an aggregation, testing these hypotheses requires independent measures of each cell. Since scRNA-Seq allows for individual measurements of distinct cells, finding similar latent spaces directly from these data would provide strong evidence of their reflection of biological, rather than technical variation. This finding suggests that latent space discovery in scRNA-Seq data will better discern biological processes, as well as true cell type and state signatures, than from bulk gene expression measurements.
ScCoGAPS finds signatures of cell types and continuous processes in the developing retina
To learn patterns directly from our scRNA-Seq data across the developing mouse retina, scCoGAPS analysis was performed using the log-transformed, normalized mRNA copies per cell across a previously selected set of high-variance genes (Fig 3A) (Clark et al., 2019). Cells were partitioned into 100 sets of ~1200 cells using a sampling scheme to ensure representation of all annotated cell types in each set. To eliminate potentially spurious patterns, consensus patterns were derived from at least 25% of the independent sets and required an R2 value of at least 0.7 to the within-cluster mean (STAR Methods).
Figure 3. scCoGAPS analysis of time course scRNA-Seq data from developing mouse retina.
(A) UMAP of scRNAseq colored by age (top) and human annotated cell types (bottom). (B) Heatmap of correlations of each scCoGAPS pattern to each annotated feature. (C) UMAP of retina development colored by scCoGAPS pattern weights illustrate cell type specific (rods, top) and shared (cell cycle, bottom) patterns. (D) Alluvial of cell type specific patterns links manually annotated cell types to scCoGAPS patterns for which at least 75% of cell of a given type have a pattern weight of >0.01.
We identified a total of 80 scCoGAPS patterns across the full developmental time course (Fig S2 and Table S2). Pattern weights were tested for significant differential cell type representations (Fig 3D) and predictive power (AUC) for each cell type annotation (Fig S1F). Because performance biases based on the choice of classifier were observed, we calculated a standard contingency table and confusion matrix using the ROCR Bioconductor package to estimate a conservative AUC for each combination of pattern and cell type annotation (Sing et al., 2005). Learned patterns corresponded to both discrete cell type signatures and continuous state transitions, including cycling retinal progenitor populations, a transient neurogenic phase, and intervals of cell type-specific maturation along developmental trajectories (Fig 3B).
We identified at least one pattern corresponding to each of the 7 major cell types in the developing retina (Fig 3B, S1F). For example, patterns with high weights in annotated horizontal cells (Patterns 2 + 16) correlated well and had high predictive power for our manually annotated horizontal cells, despite the relatively sparse number of cells of this type in our dataset. Learned patterns also highlighted gene network reuse across discrete cell types. For example, pattern 37 exhibited high weights in a subset of mature retinal ganglion cells (RGCs) and amacrine cells (Fig S1F). Additional patterns are specifically associated with mature RGCs (Pattern 15), or recover other phenotypic features of these data, such as sex (Pattern 36).
The application of scCoGAPS to scRNA-Seq data also captured technical aspects of the data as well. Combinations of biologically incompatible patterns (e.g. two patterns for distinct mature cell types within the same cell) can readily delineate doublet cell populations (Fig S5B). In contrast, standard clustering methods would aggregate doublet cells together and separately from each discrete cell type and thereby be unable to recover biological information from them, or otherwise identify them as a unique, discrete cell type. Finally, we also identified patterns associated with technical features in our scRNA-Seq dataset such as number of genes expressed (Pattern 53), or batch effects (Pattern 38). These pattern:phenotype correlations indicate that scCoGAPS recovers a collection of meaningful biological and technical patterns from the developing mouse retina scRNA-Seq data.
These correlations were able to resolve additional biological insights from these data not otherwise discernable from other analysis strategies. For example, pseudotemporal analysis was unable to resolve more closely-related cell types or trajectories with a high degree of gene reuse (Clark et al., 2019). Correlation with manual annotation and patternMarker analysis (Stein-O’Brien et al., 2017) of the associated amplitudes allowed us to resolve both differentiating horizontal cells from amacrine cells, and rods from cones (Table S3). Additional patterns were identified that correspond to continuous biological processes, i.e. cell cycle state across proliferating retinal progenitor cells (RPCs) (Patterns 14, 31, 33, 62, 49, and 78, 49), with high degrees of gene reuse (Fig 3B, 3C, S3). Additionally, many shared patterns only account for a small proportion of the cells in later-developing populations, suggesting that these transcriptional programs may be transient, or describe features associated with a subset of cells in a given lineage (Fig S5A).
To evaluate the performance of scCoGAPS relative to other commonly used single cell deconvolution methods, we compared the patterns learned from scCoGAPS with the rotations learned from singular value decomposition (SVD) and principal component analysis (PCA), feature weights from a gradient based NMF (Lee and Seung, 2001), and weights extract from the Deep Count Autoencoder (DCA) (Eraslan et al., 2018). All methods were evaluated on the same scRNA-Seq dataset from the developing mouse retina. PCA and SVD fail to capture individual cell type patterns and are driven predominantly by technical features which represent the greatest source of variation in these data (Fig S5C). Patterns learned from gradient based NMF and scCoGAPS are comparable in their maximum correlation, however the gene weights used to assess biological features for each pattern are more variable across multiple iterations of the gradient based NMF. Using the Bayesian approach implemented in scCoGAPS we can derive both mean and variance estimates allowing for variance incorporation into feature weights for gene set analysis and more robust pattern annotations (Zyla et al., 2017). Both scCoGAPS and gradient NMF outperform DCA in the number of cell type-specific latent spaces that are identified. Furthermore, DCA does not learn or export interpretable gene weights, which precludes our ability to explore the biological features represented in each of the latent spaces. Indeed, many non-linear deep learning methods using activation functions disambiguate the relationships between gene expression and learned patterns in a way that cannot be easily deconvolved.
We next sought to identify and characterize the specific cellular attributes captured in each pattern. Gene weights (A-matrix and their uncertainty) for each learned pattern were used as input for a Gene Ontology (GO) enrichment analysis using the CoGAPS gene set test (Fertig et al., 2013b) across all Kyoto Encyclopedia of Genes and Genomes (KEGG) and GO gene sets with <100 genes (Fig S1E, S3, S4). A heatmap of all significant gene set statistics for all patterns are provided in Supplemental Figures 1 and 4. Patterns which are well correlated with specific cell types are significantly enriched for appropriate gene ontologies. These include endothelial cells (9,10 and 56) which are associated with angiogenesis and blood vessel patterning, as well as microglia (5, 6, 24, 25, 27, 57, and 58), which each showed significant enrichment for immune cell activities and processes (p < 1×10−6, Fig S4, Table S4). Concordant with their selective expression in rods and cone photoreceptors, respectively, patterns 21 and 39 are enriched in phototransduction, visual perception, photoreceptor cell maintenance, and photoreceptor outer segment terms (p < 1×10−8, Fig 3C, S4, Table S4). RPC-associated patterns (13, 26, 31, 33, 45, 49, 62, 64, 72, and 78), are enriched for cell cycle regulators and embryonic development terms(p < 1×10−8, Fig S4, Table S4). Consistent with the fact that RGCs are the only neuroretinal cells that extend long projection axons, as well as the only cell to undergo high rates of apoptotic cell death during mouse retinal development (Young, 1984), the RGC-associated Patterns 15 and 35 are enriched for axon guidance, with Pattern 15 also enriched for negative regulation of apoptosis.
Single-cell patterns learned in one dataset can be transferred to another via projection analysis
To assess whether learned patterns can be meaningfully transferred across datasets, we used our developing retinal dataset as the source data and compared it to a previously published scRNA-Seq dataset from P14 mouse retina, established using a different droplet-based technique (Macosko et al., 2015). The target Drop-Seq single cell dataset was projected into the space of the 80 scCoGAPS patterns from the source 10x-based retinal development time-course data.
We hypothesized that shared latent spaces would stratify target data consistent with their underlying cellular attributes, while artifacts or data-specific features would not. Projected pattern weights were tested for predictive power (AUC) for each cell type annotation in the target Drop-Seq dataset (Fig 4; Fig S6A). Because performance biases based on the choice of classifier are known to exist, a standard contingency table and confusion matrix were calculated using the ROCR Bioconductor package to provide a highly conservative AUC for each combination of annotated cell type and pattern (Sing et al., 2005). Using the projected pattern weights and cell types we evaluated the ability of each pattern to distinguish cell types in the target dataset. (Fig S6A). Consistent with our hypothesis, AUC values confirm that patterns associated with mature cell types present in both the source and target dataset have significant predictive power (AUCs >.7, Wald test; BH-correction; q < .01), while those patterns associated with developmental processes only in the source data did not exhibit significant projections in the more mature (P14) target dataset (AUC <.7, Wald test; BH-correction; q > .01). For example, Pattern 21, which was strongly associated with rods in the retina development time-course data, selectively marked rod photoreceptors in the P14 retina Drop-Seq data (Fig 4A right panel; AUC = 0.83). Other patterns of mature cell types included Pattern 2 (AUC of 0.95 for Horizontal Cells), Pattern 55 (AUC of 0.91 for Amarcines), Pattern 15 and 16 (AUC of .93 and .92, respectively, for RGCs), and Pattern 64 (AUC of .99 for Astrocytes) (Fig 4B). In contrast, the RPC pattern 31, which was strongly enriched for GO terms associated with cell cycle, failed to yield any significant signal (Fig 4A middle panel), consistent with a lack of cycling progenitors in the P14 mouse retina.
Figure 4. projectR recovers shared cell types in independent murine retina scRNA-Seq data.
(A) UMAP of DropSeq data from P14 mouse retina colored by annotated cell type (left), projected pattern weights in Pattern 31 (center), and projected pattern weights in pattern 21 (right). (B) Alluvial plot of projected patterns links previously annotated cell types to scCoGAPS patterns for which at least 75% of cell of a given type have a significant projection (Wald test; BH-correction; q < .01). (C) ROC curves for classifiers built using the projected pattern weights for pattern 21 (right) and projected pattern weights in Pattern 31 (left). Cell types are colored according to the legend in panel A. (D) Density plots of projected pattern weights for all cell types (black) and rods only (red).
Using only the significant patterns associated with mature cell types, we are able to resolve true positive cells from background expression pattern’s projection in the target dataset as illustrated by AUC curves for the predictive power of each weights for each cell type (Fig 4C) and the distribution of projected pattern weights (Fig 4D). Patterns with poor predictive power, such as Pattern 3, exhibited weights centered around zero, while patterns with high predictive potential, such as the rod-specific Pattern 21, exhibit a bimodal distribution (Fig 4D). Cells in the target dataset annotated as rods, however, exhibit a unimodal distribution overlapping with the higher intensity peak of projected pattern weights. The cells contributing to the lower intensity peak therefore have some degree of the Pattern 21 rod signature contributing to their transcriptional profile that likely reflects contamination acquired during dissociation and library preparation. These results validate the biological basis of the scCoGAPS patterns for mature cell types and demonstrate the sensitivity and specificity of projectR as a system to transfer annotations based on factors containing shared biological features across datasets.
projectR recovers continuous processes and temporal progression from disparate data types across species
We next tested whether projection analysis could identify continuous biological features across organisms. Specifically, we projected a publicly available time course analysis of human bulk RNA-Seq from whole retinas into our single cell scCoGAPS patterns. Homologous genes were used to map the amplitude values across species (STAR Methods). Briefly, log2-transformed gene expression values from human retina bulk RNA-Seq data from gestational day 52 to 136 were projected into the 80 mouse developing patterns. Each projected pattern was evaluated for predictive power for a given human developmental time point with the expectation that the changes in predictive power should reflect the change in pattern utilization over human retinal development. The resulting AUC values revealed a temporal gradient for cell type-specific patterns, which reflects both developmental age and relative abundance of each cell type in the bulk sample (Fig 5A). Furthermore, the stereotyped birth order of major retinal cell types (Clark et al., 2019) was faithfully recapitulated in the progression of pattern projections in the human time course.
Figure 5. Projection of retina time course data reveals shared temporal dynamics across species and platforms.
(A) Heatmap of AUC values for projected pattern weights in developing whole human retina recapitulates previously established gene expression epochs. (B) Average ATAC signal for binned read counts overlapping 200 bp interval extending out 5kb on either side of the transcription start for all genes (left) or the subset of genes from which the scCoGAPS patterns were learned (right). (C) Projection of binned read counts overlapping 200 bp interval extending out 5kb on either side of the transcription start into scCoGAPS patterns 14 (top left), 31 (top right), 1 (bottom left), and 21 (bottom right).
The observed gradient reflects the previously reported three major gene expression epochs of human retina development (Hoshino et al., 2017). The first epoch includes genes with high expression from gestational day (D) 52 to D67. Patterns associated with early born cell types such as horizontal cells (pattern 1) and RGCs (pattern 15) peaked early (days 57 and 67, respectively) and then declined, reflecting their decreasing relative abundance as later-born cell types are generated. Patterns with amplitude values significantly enriched in RPC-specific processes such as cell cycle regulation (pattern 31) exhibited significant projection in the first epoch (Wald test; BH-correction; q < .01) with AUC values greater than .7 as well. Furthermore, the increased resolution of the patterns derived from scRNA-Seq allowed for a more granular association of corresponding biological processes within the larger epoch. These results indicate that shared continuous features associated with developmental programs in both mouse and human retinal development can be identified via transfer learning with projectR.
Species specific differences were also apparent in this projection analysis. For example, genes that mark mature cone and rod photoreceptors are strongly expressed postnatally in mice (Blackshaw et al., 2001, 2004; O’Brien et al., 2003) but are detected prenatally in humans. Consistent with this, Patterns 39 and 21, which are associated with mouse cones and rods, respectively, exhibit high AUC values during the third epoch of gene expression in our human projection analysis (Fig 5A) (Hoshino et al., 2017). Previous analysis of the bulk RNA-Seq data had demonstrated that differentially expressed genes within the the third epoch were enriched for gene ontology terms related to photoreceptors, synaptic connectivity, and neurotransmission (Hoshino et al., 2017). Mouse homologs of the genes annotated with these GO terms were also significantly enriched for higher amplitude values in source patterns 39 and 21 (p <.001) confirming that projectR recovered the species-specific temporal differences in the use of these patterns.
To test the ability of projectR to resolve spatiotemporal patterns, we next projected a separate bulk RNA-Seq time course of dissected regions of the human retina from Hoshino et al. (Hoshino et al., 2017). The fovea/macula has been shown to be developmentally ahead of age-matched nasal central and peripheral retina (Hendrickson and Drucker, 1992; Hendrickson et al., 2012; O’Brien et al., 2003), and enriched for both cone photoreceptors and retinal ganglion cells (Curcio and Allen, 1990). A previous differential gene expression analysis of macula vs periphery was underpowered to detect significantly differentially expressed genes at each time point. However, using the projected values for each sample, we could readily identify significant differential pattern usage (Wald test; BH- correction across patterns; q<.01) between the fovea/macula and peripheral retina at days 73 and 132. The fovea/macula is enriched in patterns specific to mature neurons, particularly retinal ganglion cells and cones (Patterns 1, 15, 39, 52) and depleted in patterns specific to retinal progenitor cells (Patterns 26, 31, 78) or immature neural precursor cells (Patterns 17, 73) relative to the age-matched peripheral retina (Fig S6B). These results demonstrate the utility of projectR in recovering spatiotemporally regulated differences within tissue/organ development.
Projection analysis can also determine pattern usage across a variety of different cellular measurement types. To illustrate this, we determined whether patterns learned from scRNA-Seq analysis of the developing mouse retina could be used to identify distinct chromatin accessibility profiles within a mouse retinal ATAC-Seq time-series obtained from FACS-isolated Chx10:GFP+ RPCs (Rowan and Cepko, 2004) collected at two day intervals between E10.5 and P2 (Fig 5B–C; Fig S7). Since ATAC-Seq profiles chromatin accessibility, rather than gene expression, projection analysis enabled identification of patterns associated with genes whose local chromatin structure is primed for transcriptional activation. For each gene, ATAC-Seq reads were quantified in 200 bp bins −5Kb to +5Kb around each canonical TSS for each time point sampled (STAR Methods). As expected, the naïve signal shows global enrichment over TSSs owing to the increased accessibility at TSS of actively transcribed genes (Buenrostro et al., 2013) (Fig 5B). Overall signal intensity was highly variable, with biological replicates from the same time point demonstrating a strong batch effect. These effects persisted when the ATAC-Seq data were subset to the same high-variance genes used to define the scCoGAPS patterns (Fig 5B right). In order to test the ability of projectR to overcome these effects, no batch correction or further data normalization was performed.
Despite the consistent profile of the observed mean enrichment of ATAC-Seq signal at the TSS across samples, projection of the ATAC-Seq into the scCoGAPS patterns revealed several classes of chromatin accessibility patterns. Different accessibility profiles emerged that are lost in aggregate. Furthermore, the shape of the accessible peak and ranking of samples is distinct across different patterns, indicating that projection analysis can recover discrete signatures of accessibility associated with latent spaces learned from gene expression profiles, independent of technical noise. Together, these results suggest that learned accessibility signatures are associated with specific biological processes at distinct developmental timepoints in the developing mouse retina. Specifically, patterns that reflected missing processes (including non-neuroretinal cell types such as microglia that were not sampled in the ATAC-Seq) demonstrate no significant signal in the projection analysis, while shared processes are apparent in both the scRNA-Seq and the ATAC-Seq data. For those projected patterns with significant ATAC-Seq signal, replicates displayed significantly tighter concordance, and the amplitudes of the projected accessibility signatures appropriately reflected temporal progressions.
Broad domains of open chromatin on either side of the transcriptional start site—a hallmark of strongly transcribed genes—are observed exclusively in patterns associated with proliferating RPCs (e.g. patterns 14,45,72,78; Fig 5C top left), consistent with the ATAC-Seq sampling of this population. Sharp peaks of open chromatin centered on the TSS corresponded to RPC-specific patterns associated with actively transcribed genes (e.g. Patterns 4,31,64; Fig 5C top right), as well as a subset of patterns associated with maturing retinal subtypes, including cones, RGCs and ACs (e.g. Patterns 1,2,15,39; Fig 5C bottom left), and immature rod photoreceptors (Pattern 79). Finally, TSS signatures of closed chromatin are associated with patterns specific to cells that are not derived from RPCs, such as microglia (5,24) and erythrocytes (28), as well as with the mature rod photoreceptor-specific Pattern 21 (Fig 5C bottom right). These data indicate that promoter regions associated with genes specific to RPC-derived cell types exist in an open and poised state in RPCs, with the notable exception of genes specific to mature rods.
ProjectR enables latent space comparison across model systems: from the developing retina to the developing brain
The retina is often used as model system for neural development. In particular, both retinal neurogenesis and corticogenesis share a stereotyped birth order of different lineages from a single progenitor population (Kohwi and Doe, 2013; Miller and Gauthier, 2007). To test the ability of projectR to identify conserved pattern usage across tissues and model systems, we projected our retinal scRNA-Seq patterns into two datasets derived from developing human cortex (Nowakowski et al., 2017) (Zhong et al., 2018), and an additional dataset of the developing mouse midbrain (La Manno et al., 2016) (Fig 6). Projection of these patterns across all cells in each of the datasets completed in 165.6, 56.0, and 3.0 seconds respectively on a single high performance computing (HPC) node with a 2.5 GHz AMD Opteron Processor 6380, and 40Gb of RAM. Consistent with a significant degree of conserved developmental programs and tissue composition between retina and select other CNS regions, we identified 87.5% (70/80), 76.3% (61/80), and 98.8% (79/80) of patterns with significant projection (q<=0.01; Wald test) in at least one cell in each of these comparable model systems (Fig 6 & S9), suggesting that many of the processes described by these patterns are reused in other CNS regions.
Figure 6. Developing brain scRNA-Seq projected in scCoGAPS patterns of retina development.
Alluvial plots connecting scCoGAPS patterns to cell types for which at least 25% of all cells are significant (Wald test; BH-correction; q < .01) in a given a projected scRNAseq of human cortical development from (A) Nowakowski, et al. and (B) Zhong, et al. as well as projected scRNAseq of mouse midbrain development from (C) La Manno et al.
For the human cortical data, patterns 5, 20, 28, 29, 31, 40, 53, 64, and 65 captured 75% of published annotated cell types (Fig S8A). Consistent with its derivation as a progenitor-associated pattern in the developing retina and GO enrichment for cell cycle, pattern 31 demonstrated significant (AUC >0.7; q<=0.01; Wald Test; BH-corrected) projection to basal intermediate progenitor cells (IPCs), IPC-derived neuronal precursors of the medial ganglionic eminence (MGE), and dividing radial glia in the cortex (Fig S9A). In cortical data from Nowakowski, et al., we observed that Pattern 43, which is specific to inhibitory amacrine cells in retina, is also associated with interneurons (Fig 6A & S9A). Newborn excitatory pyramidal neurons are enriched for genes found in both the photoreceptor precursor-enriched pattern 79 (Unc119, Meis2, Cdc43ep3), as well as the amacrine and horizontal cell-enriched pattern 1 (Nrxn3, Kdm5b, Dusp1). Additionally, we are able to classify previously unannotated cells (NA) as neurons via significant projection of Pattern 7 which is enriched for mature neuronal markers (Nnat, Tubb2b, Nefl). In data from Zhong et al., where progenitors and precursors of GABAergic interneurons are annotated as a single class, these cells were significantly associated with patterns specific to GABAergic horizontal and amacrine cells (2,43) and RPCs (49,71) (Fig 6B). In the mouse midbrain, neural progenitor cells were enriched for retinal progenitor-specific Patterns 4, 31, and 78, consistent with their shared roles in these two tissues (Fig 6C). Notably, Glyc cells in human cortex and mUnk cells in mouse midbrain—neither of which could be confidently classified in the original studies—are both enriched for patterns and genes (Tubb2b, Sox4, Mapt, Onecut2) specific to immature amacrine, horizontal and/or RGC cells, indicating that these both most likely represent as yet undescribed neuronal precursor subtypes (Fig 6C). These associations further demonstrate that projection analysis can be used to identify and annotate comparable cell types and shared cellular attributes across disparate model systems, and that information transfer faithfully recovers these associations across species (Fig S9).
Patterns 5, 6, 24, 25, and 57 are each associated with microglial cells in the original source dataset. We observe significant differences in the projections of these patterns into microglia from different CNS regions, as well as across species. Patterns 5, 24, and 25 were consistently associated with microglia in all three brain region projections(Fig 6A–C). However, Pattern 57, was significantly (q<0.01; Wald test; BH-corrected) associated with microglia in both human cortical projections, but not in microglia from the mouse midbrain (Fig 6A–B, Fig S9A–B), suggesting a potential difference in microglia signatures derived from different CNS regions. This pattern projection is driven in part by the Cathepsin family member genes Ctsb and Ctsd, as well as Cd9, each of which has been previously shown to be upregulated in a subclass of cortical microglia (Keren-Shaul et al., 2017). Thus, pattern 57 may be specifically associated with the cortically-enriched microglia type II, and highlighting a region-specific property of microglia detected via projection analysis. Additionally, no significant projections for pattern 6 were identified in either human CNS dataset (Fig 6C, Fig S8C); 0/68 (0%) annotated microglia in Zhong et al. and 0/77 (0%) microglia in Nowakowski et al. In contrast 76/77 (98.7%) microglia in the human cortical development study have significant (q<=0.01; Wald test; BH-corrected) projections into Pattern 5. Thus, using projectR we are able to discriminate region- and species-specific differences in the transcriptional signatures of discrete cell types.
Shared latent spaces identify novel cell type associations across an atlas of adult mouse tissues
Given that latent spaces may reflect the signatures of biological processes in the conditions in which they are learned, we next asked whether we could identify significant use of these processes in more diverse cellular contexts from an atlas of adult mouse tissue scRNA-Seq. The Tabula Muris dataset is a collection of 70,118 single cell gene expression profiles from 12 mouse tissues (Wyss-Coray et al., 2018) collected using the 10x Genomics Chromium platform (Fig 7A). Using projectR, we projected the Tabula Muris dataset into the developing retina latent spaces. This analysis completed in 107 seconds on a HPC node with a 2.5 GHz AMD Opteron Processor 6380 and 40Gb of RAM. Consistent with our hypothesis that biologically meaningful latent spaces will be shared across diverse cell types, 83.8% (67/80) of the patterns demonstrated significant projection (q<0.0001; Wald test) in at least one cell, and significant projections were identified in each of the 12 tissues in the Tabula Muris dataset.
Figure 7. Projection of retinal scCoGAPS patterns into mouse non-neuronal cell dataset.
(A) UMAP of scRNA-Seq data from the Tabular Muris collection of mouse tissues colored by tissue and (B) projected pattern weights in pattern 31. (C) Boxplot of projected Pattern 36 weights stratified by sex demonstrates statistically significant difference corroborating association with genes involved in X-inactivation.
Using only patterns learned in the developing retina, we were able to identify and annotate a variety of cellular features in these data. Many progenitor-associated patterns project into adult tissues with high levels of cell turnover, and specifically within subsets of cells that are actively proliferating (Fig 7B). Consistent with previous projections, Pattern 31 is highly predictive of actively mitotic cells, and can be used as a proliferative index via projection (AUC >.7) in tissues within the Tabula Muris dataset such as marrow, thymus and tongue(Fig 7B). As previously described (Clark et al., 2019), we identified pattern 36 as specifically associated with sex in our developing retinal source dataset. This association was confirmed by defining biomarkers for each factor, computed using the PatternMarker statistic (STAR Methods) (Stein-O’Brien et al., 2017) (Supplemental File 3), and finding Xist as the sole PatternMarker for Pattern 36. Projection of the Tabula Muris data set into Pattern 36 almost perfectly segregated cells by sex (Fig 7C, p-value < 2.2e-16, two way t-test). While females displayed a range of significant weights, males had uniformly insignificant projected pattern weights. In the source data, Pattern 36 has high weights in a large proportion of cells(Supplemental Video 1), but sex was not determined a priori. The projection of Pattern 36 across these two datasets provides an example of how annotations from a target dataset can also be used to annotate latent spaces from the source dataset as well.
Patterns specific to retinal neurons were detected in a number of peripheral tissues (Fig. S9A). In the trachea, Mgp+ goblet cells expressed genes associated with the neuronal cytoskeleton and neurotransmission (Gap43, Sncg, Chgb, Tac1). In the tongue, Krt6a/Krt16+ epithelial cells of both the filiform papillae (Pattern 37) and Krt14+ cells of the basal layer (Pattern 41) selectively expressed genes associated with the neuronal cytoskeleton. In the lung, a small number of cells expressed pattern markers associated with amacrine/horizontal cell-enriched Patterns 16 and 17 (Scg5, Tmsb10, Malat1, H3f3a) (Fig. S9A). Notably, this lung subpopulation expressed Ins1 and Ins2, and may thus represent a previously uncharacterised subset of pulmonary neuroendocrine cells (Fig. S9B–D). In each of these cases, none of the most highly selective marker genes of these cells types (Mgp, Krt6a/14/16, Ins1/2) were themselves expressed in retina, but rather the projected patterns identified more complex similarities in gene expression between these peripheral cell types and retinal cells. These findings illustrate the power of this approach to identify biological processes and cellular attributes shared between otherwise transcriptionally dissimilar cell types.
Discussion
The rapid expansion of high-throughput biological assays has generated massive amounts of data. Single cell experiments can now involve millions of individual samples adding to the complexity and scalability required to analyze these data. Applying latent space approaches to single cell analyses has successfully identified and corrected technical errors associated with mRNA dropout (Eraslan et al., 2018) and enabled analysis of cell-cell variation (Loos et al., 2018). However, comparing biologically meaningful molecular features across data sets remains a critical challenge. Context- dependent biological variation and technical variation both challenge the ability to make meaningful interpretations from direct comparisons of biologically distinct datasets (Lê Cao et al., 2009; Tung et al., 2017). Our approach extends the latent space concepts used for data processing to enable the comparison of biological factors across a variety of experimental paradigms and cellular contexts.
By leveraging the structure generated by the co-regulation of genes, we are able to find a reduced set of continuous factors that describe cellular identity, state, and phenotype in a model system where differential expression analysis and marker genes are insufficient alone. This result is not unique to our work (Stein-O’Brien et al., 2018). However, while previous algorithms have focused on resolving differences between samples or groups of samples (Brunet et al., 2004b; Cleary et al., 2017; Kim et al., 2017), we focus on optimizing our algorithm’s solution to account for gene and pathway reuse in scRNAseq data. scCoGAPS identifies factors using a Bayesian non-negative matrix factorization approach with a prior distribution tailored to model the sparsity of scRNA-Seq data. We developed a new computing structure and method for parallelization across all cells in a dataset to allow for computationally tractable factorizations of increasingly larger datasets such as those proposed by the Human Cell Atlas Project (Rozenblatt-Rosen et al., 2017). This parallelization strategy also allows for the independent discovery of patterns across sets of cells/samples and can be exploited to assess confidence in the learned factors which is not available from other methods. Application of scCoGAPS to time course scRNA-Seq data across mouse retina development identified gene expression signatures of discrete cell types and shared gene networks. When compared to other methods, scCoGAPS outperformed gradient based NMF and DCA when learning patterns of shared biological processes and SVD, PCA, and DCA when learning cell type specific patterns. Because DCA is optimized to denoise data, this use was outside of the intended scope of the algorithm.
ProjectR quantifies the extent to which the relationships between biological processes, inferred by dimensionality reduction methods, are shared across datasets from different assay technologies, cellular measurements, and species. Using ProjectR, independent and biologically distinct datasets, such as mouse retina and human cortex, can be compared with respect to their use of specific latent spaces. In contrast, existing tools for comparative analysis rely on consensus clustering using marker genes (Kiselev et al., 2018) or visualizations independent of specific molecular features (Cho et al., 2018). CCA (Soneson et al., 2010) and other single cell dataset comparison tools forcibly align source and target datasets into a common, shared manifold that does not reflect the native state of either dataset. Moreover, these techniques have limited applicability for differences in data dimensionality and distributions (Butler and Satija, 2017; Wang et al., 2015). By mapping target data into a basis set defined by the source data, projectR allows for the direct evaluation of what is shared between, versus what is unique to, the source and target datasets. A key challenge to such cross- study comparison arises from technical variation such as batch effects between datasets, which may be non-linear. In spite of this complexity, projectR can overcome these confounding factors to relate features across datasets from disparate measurement platforms.
Many of the applications of this transfer learning approach including cell type inference, comparison of factors across distinct conditions, feature discovery, and cross-model and cross-assay integrative analyses are areas of significant future work. The requirement of a feature map for transfer learning with projectR currently precludes its use with multi-layer autoencoders and other nonlinear methods that do not concurrently learn gene and sample weights. However, expansion of projectR to other unsupervised techniques represents an area of current and future work to bridge this gap and other methods exist that work exclusively with autoencoders (Taroni et al., 2019). Likewise, comparison of the least squares projection method employed in ProjectR to other orthogonal and non-orthogonal projection methods are also critical to determine optimal information transfer between datasets.
Application of scCoGAPS and ProjectR allows for exploratory analysis of high-dimensional biological data through the lenses of individual biological processes. This approach enables a shift in how we compare and identify cells beyond reliance on marker genes or ensemble molecular identity. Here, we demonstrate the sensitivity of this workflow to recover shared features and annotations across a variety of data types and experimental conditions. Our approach enabled de novo annotation and correction of existing cell type annotations in a target retinal scRNA-Seq study. We demonstrate the cross-platform and cross-species sensitivity of this approach to identify paralogous cell types in the retina and other tissues, and identify meaningful biological similarities in markedly different cell types in a mouse cell atlas. This approach provides a strong foundation to develop new integrative analysis approaches using low dimensional representations to describe biological systems and how specific cellular attributes are shared across biological contexts.
STAR Methods
CONTACT FOR REAGENT AND RESOURCE SHARING
Further information and requests for resources and reagents should be directed to and will be fulfilled by the Lead Contact, Elana J. Fertig (ejfertig@jhmi.edu)
EXPERIMENTAL MODEL AND SUBJECT DETAILS
Information about the generation and genotyping of the mouse transgenic lines used in this study can be found in the corresponding original studies: Chx10-Cre:GFP+ (Rowan and Cepko, 2004). All mice were maintained on a CD-1 background. Animals used for bulk RNA-seq and ATAC-Seq ranged from embryonic day 10 (E10) to postnatal day 2 (P2). Both males and females were used in this study. Mice were housed in a climate-controlled pathogen free facility, on a 14 hour-10 hour light/dark cycle (07:00 lights on-19:00 lights off). All experimental procedures were preapproved by the Institutional Animal Care and Use Committee of the Johns Hopkins University School of Medicine.
METHOD DETAILS
Single-cell RNA-Seq analysis of the developing mouse retina data obtained from Clark et al., 2019
The developmental time-series of scRNA-seq from mouse retina was generated as part of our companion manuscript (Clark et al., 2019), and these data were used for pattern discovery and annotation as described below. UMAP representations (Becht et al., 2018) were learned on neighbors calculated from the first 32 PCs using scanpy version 1.3 (Wolf et al., 2018) following data preprocessing as described in (Zheng et al., 2017).
Target public domain datasets
All data was downloaded from GEO with the exception of the Tabular Muris data which was downloaded from https://github.com/czbiohub/tabula-muris and the developing human cortex time course from (Nowakowski et al., 2017) which was downloaded from https://cells.ucsc.edu/?ds=cortex-dev. Accession numbers in order of appearance in the manuscript are GSE63472 (Macosko et al., 2015), GSE104827 (Hoshino et al., 2017), GSE104276 (Zhong et al., 2018), and GSE76381 (La Manno et al., 2016).
Bulk RNA-Seq of the developing mouse retina
At select developmental time points, cells were collected from biological replicates of FACS-sorted Chx10-Cre:GFP+ mouse retinas as previously described (Rowan and Cepko, 2004). RNA was isolated using the RNAeasy Mini kit (Qiagen) with on-column DNase treatment. Isolated total RNA was assessed for integrity on the Bioanalyzer 2100 system, and we required a minimum RNA integrity number of 7. RNA-Seq libraries were created using the Illumina TruSeq kit (Illumina), quantified via PicoGreen assay and fragment size distribution was determined using the Bioanalyzer 2100. Libraries were barcoded, pooled, and run on a HiSeq2500 instrument to an average sequencing depth of 30.0 million aligned reads per sample. 75–100bp paired-end reads were mapped to the mouse reference genome (mm10) using Hisat2 (Kim et al., 2015, 2016). Gene expression estimates for the reference transcriptome (Gencode vM5) and differential testing were performed using Cuffdiff2 (Trapnell et al., 2012) with default parameters. Data are available from GEO in GSE118880.
ATAC-Seq of the developing mouse retina obtained from Zibetti et al., 2017
Chromatin derived from flow-sorted Chx10:Cre-GFP+ (Rowan and Cepko, 2004) retinal fractions was processed as previously described (Zibetti et al., 2017). Briefly, chromatin was extracted and processed for Tn5 mediated tagmentation and adapter incorporation, according to the Manufacturer’s protocol (Nextera DNA sample preparation kit, Illumina) at 37°C for 30 min. Reduced-cycle amplification was carried out in presence of compatible indexed sequencing adapters. Libraries were quantified using the PicoGreen assay and fragment size distribution was determined using the Bioanalyzer 2100. Up to 4 samples per lane were pooled and run on a HiSeq2500 Illumina sequencer to produce 50 bp paired ends for each sample.
Bowtie2 (version 2.3.2) was used for ATAC-Seq reads alignment to the mouse genome (mm10) (Langmead and Salzberg, 2012). Duplicate reads were removed using Picard tools (version 2.10.7)(Wysoker et al., 2013). Improperly mapped reads were removed using samtools (version 1.5). (Li et al., 2009). Read counts for each gene were retrieved using featureCounts program (version 1.5.3). (Liao et al., 2014). Read counts overlapping 200 bp interval extending out 5kb on either side of the transcription start site were generated with custom scripts using bedtools (version 2.26.0)(Quinlan and Hall, 2010). Data are available from GEO in GSE118880.
QUANTIFICATION AND STATISTICAL ANALYSIS
Pattern discovery via scCoGAPS
Latent spaces were learned using the scCoGAPS function from the CoGAPS v 3.0 Bioconductor 3.7 package from log transformed CPMs of the high variance genes for all samples. Cells were partitioned into 100 sets of ~1200 cells using a sampling scheme to ensure representation of all annotated cell types in each set. Consensus patterns were derived as described in the next section using the patternMatch4scRNASeq function from the CoGAPS v 3.0 Bioconductor 3.7 package and then rerun across all sets using scCoGAPS with fixed = TRUE to ensure reciprocity of the learned weights.
CoGAPS Atomic prior
CoGAPS decomposes a matrix D of G genes (rows) and S samples (columns) into two matrices and using the model:
where the elements of Σ represent the corresponding standard deviation of each element in the matrix D. Determining the optimal value of k remains an open problem for latent space detection. The CoGAPS model assumes each element of D is i.i.d. with p(Di,j|Ai,·, P·,j, Σi,j) a normal distribution with mean μi,j = Ai,· × P·,j and variance .
In the case of sequencing data, Di,j is log transformed counts. In cases with replicates, Di,j can be replaced with the mean log transformed read counts and standard deviation can be computed across these replicates. In cases without replicates, the standard deviation is assumed to be 10% of the signal in D with a minimum value of 0.1.
CoGAPS uses an atomic prior (Sibisi and Skilling, 1997) for the andprevious work in Bayesian non-negative NMF for microarrays (Moloshok et al., 2002). The atomic prior (Sibisi and Skilling, 1997) is similar to spike and slab model (Ishwaran and Rao, 2005), in which only a subset of model parameters are non-zero and those that are have a value distributed according to some continuous distribution with non-negative support. As a result, this model results in a ℓ0 sparsity constraint on these matrices with other constraints depending on the distribution used to model non-zero values in these matrices. The atomic prior models each non-zero matrix element of A or P with a gamma distribution. The rate λA and λP of this distribution is a parameter that is fixed for every matrix element in A and P, respectively. The shape of the gamma prior for each matrix element is a separate hyperparameter ( for each element of A and for each element of P) modeled as a Poisson distribution with a fixed parameter α for each matrix element. Zero values for or correspond to Ai,j = 0 and Pk,j = 0, modeling the subset of model parameters that are zero. The expectation of the Gamma distribution is proportional to the sampled values of or , introducing a further sparsity constraint on the magnitude of the matrix elements when these values are small. In contrast to standard spike and slab models, the atomic prior also models smoothness by encoding a correlation structure between matrix elements in A and P during the sampling steps. Recall that is equivalent to the sum of independent, exponentially distributed random variables with rate parameter λA and similarly for Pk,j. Instead of directly sampling from the Gamma or Poisson distributions, the proposal distribution in the atomic prior updates a single, exponentially distributed random variable for A and for p at each step. The advantage of sampling a single atom at a time is that the conditional distribution posterior for an exponential prior on each atom and the normal likelihood is a truncated normal, enabling Gibbs sampling. This single random variable is called an “atom” and the set of all such atoms is referred to as the “atomic domain”. The value of each matrix element of A is then given by
and similarly for P. The atoms in the atomic domain are stored in ordered coordinates on a number line ( for A and for P), which is divided into bins that correspond to each matrix element (Main Figure 1). The set of all atoms for one matrix is referred to as the “atomic domain”. If the number of atoms is smaller than the number of matrix elements, this data structure reduces the memory required to keep track of each atom and provides an efficient structure to find all the atoms mapping to a single matrix elements. The prior distribution of atom coordinates is uniform, corresponding to an uniform prior for atom membership in each matrix element.
Update steps for the atomic prior
CoGAPS alternates between updating nA atoms in the A and nP atoms in the P matrices. The values of nA and nP are sampled from a Poisson distribution with parameter for the total number of atoms in the atomic domain for A(NA) and in the atomic domain for P(NP), respectively. Thus, on expectation all atoms in the domain are updated at each matrix-level iteration. The total number of such update steps is input as a parameter nEquil during the burn in stage and nSamp during the sampling stage.
In each of these nA and nP, we perform one of the four update steps to the respective atomic domains (Main Figure 1). We briefly describe these steps for A below, and note that they are defined similarly for P.
Create a single new atom in the atomic domain, so that NA ← NA + 1.
Change the value of a single atom , and removing it from the atomic domain so that NA ← NA − 1 if .
Changing the location of a single atom () to a new location between adjacent atoms ( and ) such that on the atomic domain.
Moving a portion of the value of a single atom () to another, adjacent atom () so that and where . Atoms may become small from exchange, but not exactly zero or removed from the atomic in order to maintain detailed balance.
At each of the nA or nP iterations, each of these four steps is chosen at random with 1/3 probability of either birth or death, 1/3 probability of move, and 1/3 probability of exchange. The relative probability of selecting birth or death is selected based on the Poisson prior. Recall for A that birth implies NA ← NA + 1, the sum of Poisson distributed random variables, and that under the Poisson distribution where λ is the Poisson parameter. Together, these three conditions suggest that for the A atomic domain and that for the P atomic domain. The probability of death or resize is then one minus the probability of birth. Metropolis Hastings sampling is used for the move step, whereas Gibbs sampling is used for the other three steps using the conditional distributions.
Initialization
The atomic domains for both A and P are initialized without any atoms, so that Ai,j = 0 and Pk,l = 0. This limits the initial atomic update step to birth step, birth or death when there is at least one atom in the domain, and all four update steps when there are at least two atoms in the domain. At these initial steps, the estimated fit to the data μi,j = Ai,·P·,j will be zero for most values of i and j. Thus, these initial steps do not change the likelihood and are all accepted. This initialization effectively results in initial conditions which are a random sampling from the prior before Gibbs sampling.
Conditional distributions for Gibbs sampling
We would like to sample from Skilling’s atomic domain using Gibbs sampling. We will assume that we are seeking the mass of an atom at Ak,l,j for the A matrix and at Pl,m for the P matrix. We use the variable x in the derivations below to reduced the number of indices in the equations, as the associated matrix element can be clearly inferred from the context of each equation. The initial mass of this atom is x0, which is 0 if we have decided to birth the atom and > 0 if we have decided to kill it. We retain this term so that we can derive the conditionals for birth and death in a single expression.
Determining the mass of x requires first computing the full conditional distribution p(x|x0, D, A, P). To do this, we will first consider P(A, P|D) and examine the resulting distribution. We will begin by recalling that
Putting this in terms of an individual atom, we obtain
We assume that
where M is the mock data matrix given by the product of A and P that incorporates the change in mass of the atom x − x0 in the updated term. Σ is the covariance matrix for D. The prior for the mass of each atom x is given by an exponential with parameters λA and λP, respectively.
In each case, the full conditional distribution simplifies to a normal distribution, which is truncated so that the value of the atom x ≥ 0. Below follows the detailed derivation of this distribution for birth and resizing and exchange.
Conditional distribution for birth or resizing of atoms
Atomic domain for A
We will first explore the likelihood in more detail, assuming that the mass of the atom maps to Ak,l
Since we are only concerned with computing the conditional for changes to Ak,l we note that the other terms in A and P can be considered as parameters. As a result,
Let and . Then, the equation above becomes
If we now incorporate the product with the exponential prior distribution for α
Within the code, we store values of s and s × μ used to avoid dividing by zero in cases where Pl,j = 0.
Atomic domain for P
Here, we consider atoms whose mass maps to elements Pl,m. From the likelihood, we get
If and ,
If we now incorporate the prior distribution for x
Conditional distribution for exchange between neighboring atoms in the atomic domain
Exchange for A between Ak,l and Am,n where k ≠ m
We will refer to the atom corresponding to matrix element Ak,l as x, the atom corresponding to the matrix element Am,n = xm,n, and x0 and x0,m,n there initial values, respectively. The value of x after sampling is constrained such that x ∈ (0, X) and xm,n = X − x where X = x0 + x0,m,n.
If we consider the exponential prior, the exchange step will incorporate both matrix elements. That is,
The x terms in this equation cancel, indicating that the conditional depends only on the likelihood. This occurs for all exchange steps, and thus is not described in the remaining subsections on this step.
From the likelihood, we get
For simplicity of the equations, we consider only the terms inside of the exponential and formulate them as an equation for x to find the parameters of the truncated normal for value j in the summation.
Letting μk,j = Dk,j − ΣpAk,p Pp,j and Mm,n,j = XPn,j + ΣpAm,p Pp,j − Dm,j, the above term simplifies to
Combining terms, we can write this equation as
which can complete the square by
The parameters for the truncated normal can now follow the derivation used for the birth step described above.
Exchange for A between Ak,l and Ak,n
Considering just the terms inside of the exponent, in this case we will have instead
Collecting the x terms and completing the square we get
we let and . The derivation for the terms of the truncated normal follow.
Exchange for P between Pk,l and Pm,n where l ≠ n
The derivation for exchange steps in P follows that of the derivation for A above. In this case,
where μi,l = Di,l − Σp Ai,p Pp,l and Mi,m,n = Σp Ai,p Pp,n + XAi,m − Di,n.
Exchange for P between Pk,l and Pm,l
The derivation for the exchange steps for P follows that of the derivation for A. Thus, in this case
Annealing parameter
During the equilibration phase, we in fact wish to sample from the conditional distribution
where T is the annealing temperature. This has the effect of multiplying the term σ in each of the equations by a factor of T. As a result, the standard deviation s of the birth and resize terms are the only things to change by as follows.
A similar modification of the terms with σ ← Tσ will also occur in the exchange step, which will modify both the mean and standard deviation terms for this step.
Pattern matching for consensus gene signatures
Hierarchical clustering was done on gene weights from all sets and the resulting dendrogram is cut so that the number of branches is equal to the original number of latent spaces. Each branch then contains the columns(s) of A across all of the sets that are most related to each other. Well-dimensionalized data will produce robust patterns such that each branch will contain a single contribution from each of the randomly generated sets. As the additional sparsity can cause large clusters driven predominantly by zeros, the minimum and maximum number of patterns contributing to given branch can be specified with defaults of .5 and 1.5 the number of gene sets, respectively. Branches failing to meet the lower bound are dropped, while those exceeding the upper bound are subjected to additional rounds of hierarchical clustering. Additionally, the minimal correlation to the cluster mean for each pattern within a given branch was specified to be 0.7. Consensus signatures were then constructed for each branch by taking a weighted average of the gene signatures for that branch which pass all the criteria. To ease across pattern comparison, the resulting consensus signatures were scaled to have maxima of one. Pattern weights for all the cells were then learned in parallel from these signatures to ensure reciprocity across all of the sets.
Pattern curation using manual feature annotation
The AUC valued were calculated by inputing either the pattern weights output from scCoGAPs, the projected pattern weights output from projectR, or the p-values output from projectR with a one hot encoded matrix of annotated labels into the prediction function of the ROCR library v 1.0–7. The output of prediction was then evaluate using the performance function with method=auc from the ROCR library v 1.0–7 and the y.values extracted and reported. Note this process has been functionalize and is included in the projectR package v .99 as the auc_mat function. The heatmap in Figure 3B was created using the following. Each feature of contained in the annotation matrix was one hot encoded and the resulting vector correlated against the pattern weights generated by scCoGAPS for each cell.
Benchmarking scCoGAPS against commonly used dimensionality reduction tools
SVD was calculated using the svd function with nu=80, nv=80 from the base R package v3.5.2. PCA was calculated with the scale and centered arguments as true using prcomp functions included in the core R stats package v 3.5.2. The gradient bases NMF was run using the both the nmf function from the NMF library v 0.21.0 with method set to “brunet” and k = 80 and the nnmf function from the NNLM library v 0.4.2 with threads set to 24. DCA was run in using dca.api in Python 3.6 the with arguments mode=‘latent’, hidden_size=80, return_info=True, return_model=True.
Gene set analysis of scCoGAPS patterns
Z-scores of gene weights were computed for each pattern in each ensemble by dividing the mean of the A matrix estimated across the chain by its standard deviation as previously described (Fertig et al., 2010; Ochs et al., 2009). The resulting matrix of Z-scores is averaged for sets of patterns determined to match in the the ensemble as described above. A Wilcoxon gene set test with the R/Bioconductor LIMMA package version 3.36.2 (Ritchie et al., 2015) is performed for mouse KEGG and GO sets from the R/Bioconductor packages org.Mm.eg.db version 3.4.0, KEGG.db version 3.2.3, and GO.db version 3.4.0. Gene sets with more than 5 genes and fewer than 100 genes are retained for analysis. P-values for the gene set test are FDR adjusted with Benjamini Hotchberg and available as Table S4. Preranked GSEA was performed for the results of the gradient based NMF from the NMF library gene set test (Subramanian et al., 2005).
projectR analysis
The R package projectR version 0.99.2 (available from https://github.com/genesofeve/projectR) was used to project the scCoGAPS consensus scCoGAPS patterns of the A matrix into each of the target datasets. These projection are achieved by solving the factorization
using the least-squares fit to the new data as implemented via a wrapper for the lmFit function in the LIMMA package 3.30.13 (Ritchie et al., 2015). Specifically, a linear model is fit using the Ai,j weights learned from the source data by scCoGAPS as the design matrix for multiple linear regressions. Each row of the design matrix, Ai,·, corresponds to the features, i.e. genes, which will map between the source and target data. Each column of the design matrix, A·,j, corresponds to a previously learned individual latent space. The estimated coefficients of these regressions provide matrix values for the target data. These s score the new samples using a gene-wise weighting, provided by the As, for each latent space. The ranking of the new samples within each pattern, or row of , are then indicative of the relative strength of a given sample’s association with the latent space. A wald test to calculate the significance of these coefficients is calculated using the pdf of the negative absolute value of the coefficients scaled by their standard deviation, i.e.
The AUC values were calculated by inputting either the projected pattern weights output from projectR or the p-values output from projectR with a one hot encoded matrix of annotated labels into the prediction function of the ROCR library v 1.0–7. The output of prediction was then evaluate using the performance function with method=auc from the ROCR library v 1.0–7 and the y.values extracted and reported. Note this process has been functionalized and is included in the projectR package v .99 as the auc_mat function. Additional functionality is included in the latest version of ProjectR (v 1.0) available as part of Bioconductor.
DATA AND SOFTWARE AVAILABILITY
scCoGAPS is available as part of the CoGAPS bioconductor package (3.8) under the GPL license. ProjectR is available as part of the ProjectR bioconductor package (1.0) under the GPL license. Note, the exact version used for this analysis (v0.99.2) can be freely downloaded from https://github.com/genesofeve/projectR. All code for this analysis is available upon request. Bulk RNA-seq data generated for this paper are available in GEO in GSE118880.
Supplementary Material
Table S1. Related to STAR Methods and Figure S1. Amplitude values and pattern weights from GWCoGAPS on retina development time course of Chx:GFP+ and negative bulk RNA-Seq samples.
Table S2. Related to Figure 3 and Figure S2–S5. Amplitude values and pattern weights for scCoGAPS analysis of mouse retinal development scRNA-Seq data
Table S3. Related to Figure 3 and Figure S2–S5. PatternMarkers for scCoGAPS analysis of mouse retinal development scRNA-Seq data
Table S4. Related to Figure 3 and Figure S2–S5. Gene set enrichment of scCoGAPS amplitude values from analysis of mouse retinal development scRNA-Seq data
KEY RESOURCES TABLE
| REAGENT or RESOURCE | SOURCE | IDENTIFIER |
|---|---|---|
| Critical Commercial Assays | ||
| RNAeasy Mini kit | Qiagen | Cat#74134 |
| Illumina TruSeq kit | Illumina | Cat#RS-122–2001 |
| Deposited Data | ||
| Bulk RNAseq of Chx10-Cre:GFP+ cells from a time course of murine retina | This paper | GSE118880 |
| 10x scRNAseq time course of murine retina development | Clark et al., 2019 | GSE118880 |
| ATAC seq of Chx10-Cre:GFP+ cells from a time course of murine retina development | Zibetti et al., 2017 | GSE118880 |
| Tabula Muris data | CZI Biohub | https://github.com/czbiohub/tabula-muris |
| Developing human cortex time course | Nowakowski et al., 2017 | https://cells.ucsc.edu/?ds=cortex-dev |
| Adult murine retina scRNAseq | Macosko et al., 2015 | GSE63472 |
| Developing murine midbrain scRNAseq | La Manno et al., 2016 | GSE76381 |
| Developing human cortex scRNAseq | Zhong et al., 2018 | GSE104276 |
| Bulk RNAseq time course of human retina development | Hoshino et al., 2017 | GSE104827 |
| Experimental Models: Organisms/Strains | ||
| Mice:CD1.Tg(Chx10-EGFP/cre/-ALPP)2Clc | Dr. Connie Cepko; {Rowan, 2004 #1454} | RRID:MGI:3838985 |
| Software and Algorithms | ||
| R version 3.5 | The R project | https://www.r-project.org/ |
| scanpy version 1.3 | Wolf et al., 2018 | https://github.com/theislab/scanpy |
| scCoGAPS | bioconductor | https://www.bioconductor.org/packages/release/bioc/html/CoGAPS.html |
| projectR | This paper | https://github.com/genesofeve/projectR |
| Deep Count Autoencoder (DCA) | Eraslan et al., 2018 | https://github.com/theislab/dca |
| NNLM | Lee and Seung, 2001 | https://cran.r-project.org/web/packages/NNLM/vignettes/Fast-And-Versatile-NMF.html |
Highlights.
Latent spaces provide greater insight into biological systems than marker genes alone
scCoGAPS learns biologically meaningful latent spaces from sparse scRNA-Seq data
Transfer learning (TL) enables discovery across experimental systems and species
ProjectR is a TL framework to rapidly explore latent spaces across independent datasets
Acknowledgements
This work was supported by grants from the NIH (R01EY020560 and U01EY027267 to SB, F32EY024201 and K99EY027844 to BSC, R01CA177669, U01CA196390, U01CA212007, and P30CA006973 to EJF), the NSF (IOS-1656592 to LAG), the Chan-Zuckerberg Initiative DAF (2018–182718 for QH, 2018–183445 to LAG, and 2018–183444 to EJF) an advised fund of Silicon Valley Community Foundation, the Johns Hopkins University Catalyst (EF & LAG) and Discovery awards (EJF), and the Johns Hopkins University School of Medicine Synergy Award (SB, LAG, & EJF). QH would like to thank J. Taroni for discussions on transfer learning and low dimensional representations. The authors would like to thank C.A. Berlinicke and D.J. Zack for assistance with FACS analysis, A. Wolf and F. Theis from the Helmholtz Center, Munich, Germany for productive discussions and introductory scanpy code, the Johns Hopkins Genetic Resources Core Facility for use of the 10x Genomics Single Cell system, and the Hopkins Microarray and Deep Sequencing Core for assistance with sequencing; the CZI Jamboree, C. Greene, K. Korthauer, and A. V. Favorov for invaluable collaborations and discussions; and A. Battle, V. Yegnasubramanian, and J. Bader for comments on the manuscript.
Footnotes
Publisher's Disclaimer: This is a PDF file of an unedited manuscript that has been accepted for publication. As a service to our customers we are providing this early version of the manuscript. The manuscript will undergo copyediting, typesetting, and review of the resulting proof before it is published in its final citable form. Please note that during the production process errors may be discovered which could affect the content, and all legal disclaimers that apply to the journal pertain.
Declaration of Interests The authors declare no competing interests.
References
- Bassett EA, and Wallace VA (2012). Cell fate determination in the vertebrate retina. Trends Neurosci. 35, 565–573. [DOI] [PubMed] [Google Scholar]
- Becht E, McInnes L, Healy J, Dutertre C-A, Kwok IWH, Ng LG, Ginhoux F, and Newell EW (2018). Dimensionality reduction for visualizing single-cell data using UMAP. Nat. Biotechnol [DOI] [PubMed] [Google Scholar]
- Bidaut G, and Ochs MF (2004). ClutrFree: cluster tree visualization and interpretation. Bioinformatics 20, 2869–2871. [DOI] [PubMed] [Google Scholar]
- Blackshaw S, Fraioli RE, Furukawa T, and Cepko CL (2001). Comprehensive analysis of photoreceptor gene expression and the identification of candidate retinal disease genes. Cell 107, 579–589. [DOI] [PubMed] [Google Scholar]
- Blackshaw S, Harpavat S, Trimarchi J, Cai L, Huang H, Kuo WP, Weber G, Lee K, Fraioli RE, Cho S-H, et al. (2004). Genomic analysis of mouse retinal development. PLoS Biol. 2, E247. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Brunet J-P, Tamayo P, Golub TR, and Mesirov JP (2004a). Metagenes and molecular pattern discovery using matrix factorization. Proceedings of the National Academy of Sciences 101, 4164–4169. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Brunet JP, Brunet J-P, Tamayo P, Tamayo P, Golub TR, Golub TR, Mesirov JP, and Mesirov JP (2004b). Metagenes and molecular pattern discovery using matrix factorization. Proc. Natl. Acad. Sci. U. S. A 101, 4164–4169. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Buenrostro JD, Giresi PG, Zaba LC, Chang HY, and Greenleaf WJ (2013). Transposition of native chromatin for fast and sensitive epigenomic profiling of open chromatin, DNA-binding proteins and nucleosome position. Nat. Methods 10, 1213–1218. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Butler A, and Satija R (2017). Integrated analysis of single cell transcriptomic data across conditions, technologies, and species. bioRxiv. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ching T, Huang S, and Garmire LX (2014). Power analysis and sample size estimation for RNA-Seq differential expression. RNA 20, 1684–1696. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Cho H, Berger B, and Peng J (2018). Generalizable and Scalable Visualization of Single-Cell Data Using Neural Networks. Cell Syst 7, 185–191.e4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Clark B, Stein-O’Brien G, Shiau F, Cannon G, Davis E, Sherman T, Rajaii F, James-Esposito R, Gronostajski R, Fertig E, et al. (2019). Single cell RNA-Seq analysis of retinal development identifies NFI factors as regulating mitotic exit and late-born cell specification. Neuron X, XXX–XXX [DOI] [PMC free article] [PubMed] [Google Scholar]
- Cleary B, Cong L, Cheung A, Lander ES, and Regev A (2017). Efficient Generation of Transcriptomic Profiles by Random Composite Measurements. Cell 171, 1424–1436.e18. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Curcio CA, and Allen KA (1990). Topography of ganglion cells in human retina. J. Comp. Neurol 300, 5–25. [DOI] [PubMed] [Google Scholar]
- Eraslan G, Simon LM, Mircea M, Mueller NS, and Theis FJ (2018). Single cell RNA-seq denoising using a deep count autoencoder. bioRxiv. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Fertig EJ, Ding J, Favorov AV, Parmigiani G, and Ochs MF (2010). CoGAPS: an R/C++ package to identify patterns and biological process activity in transcriptomic data. Bioinformatics 26, 2792–2793. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Fertig EJ, Markovic A, Danilova LV, Gaykalova DA, Cope L, Chung CH, Ochs MF, and Califano JA (2013a). Preferential Activation of the Hedgehog Pathway by Epigenetic Modulations in HPV Negative HNSCC Identified with Meta-Pathway Analysis. PLoS One 8, e78127. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Fertig EJ, Favorov AV, and Ochs MF (2013b). Identifying context-specific transcription factor targets from prior knowledge and gene expression data. IEEE Trans. Nanobioscience 12, 142–149. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Hendrickson A, and Drucker D (1992). The development of parafoveal and mid-peripheral human retina. Behav. Brain Res. 49, 21–31. [DOI] [PubMed] [Google Scholar]
- Hendrickson A, Possin D, Vajzovic L, and Toth CA (2012). Histologic development of the human fovea from midgestation to maturity. Am. J. Ophthalmol 154, 767–778.e2. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Hoshino A, Ratnapriya R, Brooks MJ, Chaitankar V, Wilken MS, Zhang C, Starostik MR, Gieser L, La Torre A, Nishio M, et al. (2017). Molecular Anatomy of the Developing Human Retina. Dev. Cell 43, 763–779.e4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ishwaran H, and Rao JS. (2005). Spike and Slab Variable Selection: Frequentist and Bayesian Strategies. Annals of Applied Statistics 33, 730–73. [Google Scholar]
- Javed A, and Cayouette M (2017). Temporal Progression of Retinal Progenitor Cell Identity: Implications in Cell Replacement Therapies. Front. Neural Circuits 11, 105. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Keren-Shaul H, Spinrad A, Weiner A, Matcovitch-Natan O, Dvir-Szternfeld R, Ulland TK, David E, Baruch K, Lara-Astaiso D, Toth B, et al. (2017). A Unique Microglia Type Associated with Restricting Development of Alzheimer’s Disease. Cell 169, 1276–1290.e17. [DOI] [PubMed] [Google Scholar]
- Kim D, Langmead B, and Salzberg SL (2015). HISAT: a fast spliced aligner with low memory requirements. Nat. Methods 12, 357–360. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kim D, Langmead B, and Salzberg SL (2016). HISAT2 implementation.
- Kim JW, Abudayyeh OO, Yeerna H, Yeang C-H, Stewart M, Jenkins RW, Kitajima S, Konieczkowski DJ, Medetgul-Ernar K, Cavazos T, et al. (2017). Decomposing Oncogenic Transcriptional Signatures to Generate Maps of Divergent Cellular States. Cell Syst 5, 105–118.e9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kiselev VY, Yiu A, and Hemberg M (2018). scmap: projection of single-cell RNA-seq data across data sets. Nat. Methods 15, 359–362. [DOI] [PubMed] [Google Scholar]
- Kiselev VY, Andrews TS, and Hemberg M (2019). Challenges in unsupervised clustering of single-cell RNA-seq data. Nat. Rev. Genet [DOI] [PubMed] [Google Scholar]
- Kohwi M, and Doe CQ (2013). Temporal fate specification and neural progenitor competence during development. Nat. Rev. Neurosci 14, 823–838. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kossenkov AV, Peterson AJ, and Ochs MF (2007). Determining transcription factor activity from microarray data using Bayesian Markov chain Monte Carlo sampling. Stud. Health Technol. Inform 129, 1250–1254. [PubMed] [Google Scholar]
- La Manno G, Gyllborg D, Codeluppi S, Nishimura K, Salto C, Zeisel A, Borm LE, Stott SRW, Toledo EM, Villaescusa JC, et al. (2016). Molecular Diversity of Midbrain Development in Mouse, Human, and Stem Cells. Cell 167, 566–580.e19. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Langmead B, and Salzberg SL (2012). Fast gapped-read alignment with Bowtie 2. Nat. Methods 9, 357–359. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Lê Cao K-A, Martin PGP, Robert-Granié C, and Besse P (2009). Sparse canonical methods for biological data integration: application to a cross-platform study. BMC Bioinformatics 10, 34. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Lee DD, and Seung HS (1999). Learning the parts of objects by non-negative matrix factorization. Nature. [DOI] [PubMed] [Google Scholar]
- Lee DD, and Seung HS (2001). Algorithms for Non-negative Matrix Factorization In Advances in Neural Information Processing Systems 13, Leen TK, Dietterich TG, and Tresp V, eds. (MIT Press; ), pp. 556–562. [Google Scholar]
- Li H, Handsaker B, Wysoker A, Fennell T, Ruan J, Homer N, Marth G, Abecasis G, Durbin R, and 1000 Genome Project Data Processing Subgroup (2009). The Sequence Alignment/Map format and SAMtools. Bioinformatics 25, 2078–2079. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Liao Y, Smyth GK, and Shi W (2014). featureCounts: an efficient general purpose program for assigning sequence reads to genomic features. Bioinformatics 30, 923–930. [DOI] [PubMed] [Google Scholar]
- Loos C, Moeller K, Fröhlich F, Hucho T, and Hasenauer J (2018). A Hierarchical, Data-Driven Approach to Modeling Single-Cell Populations Predicts Latent Causes of Cell-To-Cell Variability. Cell Syst 6, 593–603.e13. [DOI] [PubMed] [Google Scholar]
- Macosko EZ, Basu A, Satija R, Nemesh J, Shekhar K, Goldman M, Tirosh I, Bialas AR, Kamitaki N, Martersteck EM, et al. (2015). Highly Parallel Genome-wide Expression Profiling of Individual Cells Using Nanoliter Droplets. Cell 161, 1202–1214. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Miller FD, and Gauthier AS (2007). Timing is everything: making neurons versus glia in the developing cortex. Neuron 54, 357–369. [DOI] [PubMed] [Google Scholar]
- Moloshok TD, Klevecz RR, Grant JD, Manion FJ, Speier WF 4th, and Ochs MF (2002). Application of Bayesian decomposition for analysing microarray data. Bioinformatics 18, 566–575. [DOI] [PubMed] [Google Scholar]
- Nowakowski TJ, Bhaduri A, Pollen AA, Alvarado B, Mostajo-Radji MA, Di Lullo E, Haeussler M, Sandoval-Espinosa C, Liu SJ, Velmeshev D, et al. (2017). Spatiotemporal gene expression trajectories reveal developmental hierarchies of the human cortex. Science 358, 1318–1323. [DOI] [PMC free article] [PubMed] [Google Scholar]
- O’Brien KMB, Schulte D, and Hendrickson AE (2003). Expression of photoreceptor-associated molecules during human fetal eye development. Mol. Vis 9, 401–409. [PubMed] [Google Scholar]
- Ochs MF, and Fertig EJ (2012). Matrix Factorization for Transcriptional Regulatory Network Inference … Bioinformatics and Computational Biology … 1–10. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ochs MF, Rink L, Tarn C, Mburu S, Taguchi T, Eisenberg B, and Godwin AK (2009). Detection of Treatment-Induced Changes in Signaling Pathways in Gastrointestinal Stromal Tumors Using Transcriptomic Data. Cancer Res. 69, 9125–9132. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Pan SJ, Kwok JT, and Yang Q (2008). Transfer learning via dimensionality reduction. AAAI. [Google Scholar]
- Quinlan AR, and Hall IM (2010). BEDTools: a flexible suite of utilities for comparing genomic features. Bioinformatics 26, 841–842. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ritchie ME, Phipson B, Wu D, Hu Y, Law CW, Shi W, and Smyth GK (2015). limma powers differential expression analyses for RNA-sequencing and microarray studies. Nucleic Acids Res. 43, e47. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Rowan S, and Cepko CL (2004). Genetic analysis of the homeodomain transcription factor Chx10 in the retina using a novel multifunctional BAC transgenic mouse reporter. Dev. Biol 271, 388–402. [DOI] [PubMed] [Google Scholar]
- Rozenblatt-Rosen O, Stubbington MJT, Regev A, and Teichmann SA (2017). The Human Cell Atlas: from vision to reality. Nature 550, 451–453. [DOI] [PubMed] [Google Scholar]
- Sibisi S, and Skilling J (1996). Bayesian Density Estimation In Maximum Entropy and Bayesian Methods, pp. 189–198. [Google Scholar]
- Sibisi S, and Skilling J. (1997). Prior Distributions on Measure Space. Journal of the Royal Statistical Society, B 59, 217–35. [Google Scholar]
- Sing T, Sander O, Beerenwinkel N, and Lengauer T (2005). ROCR: visualizing classifier performance in R. Bioinformatics 21, 3940–3941. [DOI] [PubMed] [Google Scholar]
- Skilling J, and Sibisi S (1996). Priors on Measures In Maximum Entropy and Bayesian Methods, pp. 261–270. [Google Scholar]
- Soneson C, Lilljebjörn H, Fioretos T, and Fontes M (2010). Integrative analysis of gene expression and copy number alterations using canonical correlation analysis. BMC Bioinformatics 11, 191. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Stein-O’Brien GL, Carey JL, Lee W-S, Considine M, Favorov AV, Flam E, Guo T, Li S, Marchionni L, Sherman T, et al. (2017). PatternMarkers & GWCoGAPS for novel data-driven biomarkers via whole transcriptome NMF. Bioinformatics. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Stein-O’Brien GL, Arora R, Culhane AC, Favorov AV, Garmire LX, Greene CS, Goff LA, Li Y, Ngom A, Ochs MF, et al. (2018). Enter the Matrix: Factorization Uncovers Knowledge from Omics. Trends Genet. 34, 790–805. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Subramanian A, Tamayo P, Mootha VK, Mukherjee S, Ebert BL, Gillette MA, Paulovich A, Pomeroy SL, Golub TR, Lander ES, et al. (2005). Gene set enrichment analysis: a knowledge-based approach for interpreting genome-wide expression profiles. Proc. Natl. Acad. Sci. U. S. A 102, 15545–15550. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Tabula Muris Consortium, Overall coordination, Logistical coordination, Organ collection and processing, Library preparation and sequencing, Computational data analysis, Cell type annotation, Writing group, Supplemental text writing group, and Principal investigators (2018). Single-cell transcriptomics of 20 mouse organs creates a Tabula Muris. Nature 562, 367–372. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Taroni JN, Grayson PC, Hu Q, Eddy S, Kretzler M, Merkel PA, and Greene CS (2019). MultiPLIER: a transfer learning framework for transcriptomics reveals systemic features of rare disease. Cell Systems XX, XXX–XXX. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Torrey L, and Shavlik J (2009). Transfer Learning In Handbook of Research on Machine Learning Applications and Trends Algorithms, Methods, and Techniques, Olivas ES, ed. pp. 242–264. [Google Scholar]
- Trapnell C, Hendrickson DG, Sauvageau M, Goff L, Rinn JL, and Pachter L (2012). Differential analysis of gene regulation at transcript resolution with RNA-seq. Nat. Biotechnol 31, 46–53. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Tung P-Y, Blischak JD, Hsiao CJ, Knowles DA, Burnett JE, Pritchard JK, and Gilad Y (2017). Batch effects and the effective design of single-cell gene expression studies. Sci. Rep 7, 39921. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Wagner A, Regev A, and Yosef N (2016). Revealing the vectors of cellular identity with single-cell genomics. Nat. Biotechnol [DOI] [PMC free article] [PubMed] [Google Scholar]
- Wang W, Arora R, Livescu K, and Bilmes JA (2015). Unsupervised learning of acoustic features via deep canonical correlation analysis. In 2015 IEEE International Conference on Acoustics, Speech and Signal Processing (ICASSP), pp. 4590–4594. [Google Scholar]
- Wolf FA, Angerer P, and Theis FJ (2018). SCANPY: large-scale single-cell gene expression data analysis. Genome Biol. 19, 15. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Wysoker A, Tibbetts K, and Fennell T (2013). Picard tools version 1.90.
- Wyss-Coray T, Darmanis S, and Muris Consortium T (2018). Single-cell transcriptomic characterization of 20 organs and tissues from individual mice creates a Tabula Muris. bioRxiv. [Google Scholar]
- Young RW (1984). Cell death during differentiation of the retina in the mouse. J. Comp. Neurol 229, 362–373. [DOI] [PubMed] [Google Scholar]
- Zappia L, Phipson B, and Oshlack A (2018). Exploring the single-cell RNA-seq analysis landscape with the scRNA-tools database. PLoS Comput. Biol 14, e1006245. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zheng C, Zheng L, Yoo J-K, Guo H, Zhang Y, Guo X, Kang B, Hu R, Huang JY, Zhang Q, et al. (2017). Landscape of Infiltrating T Cells in Liver Cancer Revealed by Single-Cell Sequencing. Cell 169, 1342–1356.e16. [DOI] [PubMed] [Google Scholar]
- Zhong S, Zhang S, Fan X, Wu Q, Yan L, Dong J, Zhang H, Li L, Sun L, Pan N, et al. (2018). A single-cell RNA-seq survey of the developmental landscape of the human prefrontal cortex. Nature. [DOI] [PubMed] [Google Scholar]
- Zhu X, Ching T, Pan X, Weissman SM, and Garmire L (2017). Detecting heterogeneity in single-cell RNA-Seq data by non-negative matrix factorization. PeerJ 5, e2888. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zibetti C, Liu S, Wan J, Qian J, and Blackshaw S (2017). Lhx2 regulates temporal changes in chromatin accessibility and transcription factor binding in retinal progenitor cells.
- Zyla J, Marczyk M, Weiner J, and Polanska J (2017). Ranking metrics in gene set enrichment analysis: do they matter? BMC Bioinformatics 18, 256. [DOI] [PMC free article] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Table S1. Related to STAR Methods and Figure S1. Amplitude values and pattern weights from GWCoGAPS on retina development time course of Chx:GFP+ and negative bulk RNA-Seq samples.
Table S2. Related to Figure 3 and Figure S2–S5. Amplitude values and pattern weights for scCoGAPS analysis of mouse retinal development scRNA-Seq data
Table S3. Related to Figure 3 and Figure S2–S5. PatternMarkers for scCoGAPS analysis of mouse retinal development scRNA-Seq data
Table S4. Related to Figure 3 and Figure S2–S5. Gene set enrichment of scCoGAPS amplitude values from analysis of mouse retinal development scRNA-Seq data
Data Availability Statement
scCoGAPS is available as part of the CoGAPS bioconductor package (3.8) under the GPL license. ProjectR is available as part of the ProjectR bioconductor package (1.0) under the GPL license. Note, the exact version used for this analysis (v0.99.2) can be freely downloaded from https://github.com/genesofeve/projectR. All code for this analysis is available upon request. Bulk RNA-seq data generated for this paper are available in GEO in GSE118880.







