--- title: Analyzing single-cell RNA-seq data containing read counts author: - name: Aaron T. L. Lun affiliation: &CRUK Cancer Research UK Cambridge Institute, Li Ka Shing Centre, Robinson Way, Cambridge CB2 0RE, United Kingdom - name: Davis J. McCarthy affiliation: - &EMBL EMBL European Bioinformatics Institute, Wellcome Genome Campus, Hinxton, Cambridge CB10 1SD, United Kingdom - St Vincent's Institute of Medical Research, 41 Victoria Parade, Fitzroy, Victoria 3065, Australia - name: John C. Marioni affiliation: - *CRUK - *EMBL - Wellcome Trust Sanger Institute, Wellcome Genome Campus, Hinxton, Cambridge CB10 1SA, United Kingdom date: "`r Sys.Date()`" vignette: > %\VignetteIndexEntry{Analyzing scRNA-seq read count data} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} output: BiocStyle::html_document bibliography: ref.bib --- ```{r style, echo=FALSE, results='hide', message=FALSE} library(BiocStyle) library(knitr) opts_chunk$set(error=FALSE, message=FALSE, warning=FALSE) opts_chunk$set(fig.asp=1) ``` ```{r, echo=FALSE, results='hide'} all.urls <- c("https://www.ebi.ac.uk/arrayexpress/files/E-MTAB-5522/E-MTAB-5522.processed.1.zip", "https://www.ebi.ac.uk/arrayexpress/files/E-MTAB-5522/E-MTAB-5522.sdrf.txt") all.basenames <- basename(all.urls) all.modes <- c("wb", "w") for (x in seq_along(all.urls)) { if (!file.exists(all.basenames[x])) { download.file(all.urls[x], all.basenames[x], mode=all.modes[x]) } } ``` # Overview In this workflow, we use a relatively simple dataset [@lun2017assessing] to introduce most of the concepts of scRNA-seq data analysis. This dataset contains two plates of 416B cells (an immortalized mouse myeloid progenitor cell line), processed using the Smart-seq2 protocol [@picelli2014fulllength]. A constant amount of spike-in RNA from the External RNA Controls Consortium (ERCC) was also added to each cell's lysate prior to library preparation. High-throughput sequencing was performed and the expression of each gene was quantified by counting the total number of reads mapped to its exonic regions. Similarly, the quantity of each spike-in transcript was measured by counting the number of reads mapped to the spike-in reference sequences. Counts for all genes/transcripts in each cell were obtained from ArrayExpress using the accession number [E-MTAB-5522](https://www.ebi.ac.uk/arrayexpress/experiments/E-MTAB-5522). # Setting up the data ## Loading in the count matrix Our first task is to load the count matrices into memory. One matrix was generated for each plate of cells used in the study. In each matrix, each row represents an endogenous gene or a spike-in transcript, and each column represents a cell. Subsequently, the count in each entry of the matrix represents the number of reads mapped to a particular gene/transcript in a particular cell. ```{r} unzip("E-MTAB-5522.processed.1.zip") # Reading in the count tables for each of the two plates. plate1 <- read.delim("counts_Calero_20160113.tsv", header=TRUE, row.names=1, check.names=FALSE) plate2 <- read.delim("counts_Calero_20160325.tsv", header=TRUE, row.names=1, check.names=FALSE) gene.lengths <- plate1$Length # First column is the gene length. plate1 <- as.matrix(plate1[,-1]) # Discarding gene length (as it is not a cell). plate2 <- as.matrix(plate2[,-1]) rbind(Plate1=dim(plate1), Plate2=dim(plate2)) ``` We combine the two matrices into a single object for further processing. This is done after verifying that the genes are in the same order between the two matrices. ```{r} stopifnot(identical(rownames(plate1), rownames(plate2))) all.counts <- cbind(plate1, plate2) ``` For convenience, the count matrix is stored in a `SingleCellExperiment` object from the `r Biocpkg("SingleCellExperiment")` package. This allows different types of row- and column-level metadata to be stored alongside the counts for synchronized manipulation throughout the workflow. ```{r} library(SingleCellExperiment) sce <- SingleCellExperiment(list(counts=all.counts)) rowData(sce)$GeneLength <- gene.lengths sce ``` We identify the rows corresponding to ERCC spike-in transcripts from the row names. We store this information in the `SingleCellExperiment` object for future use. This is necessary as spike-ins require special treatment in downstream steps such as normalization. ```{r} isSpike(sce, "ERCC") <- grepl("^ERCC", rownames(sce)) summary(isSpike(sce, "ERCC")) ``` This dataset is slightly unusual in that it contains information from another set of spike-in transcripts, the Spike-In RNA Variants (SIRV) set. For simplicity, we will only use the ERCC spike-ins in this analysis. Thus, we must remove the rows corresponding to the SIRV transcripts prior to further analysis, which can be done simply by subsetting the `SingleCellExperiment` object. ```{r} is.sirv <- grepl("^SIRV", rownames(sce)) sce <- sce[!is.sirv,] summary(is.sirv) ``` **Comments from Aaron:** - Some feature-counting tools will report mapping statistics in the count matrix (e.g., the number of unaligned or unassigned reads). While these values can be useful for quality control, they would be misleading if treated as gene expression values. Thus, they should be removed (or at least moved to the `colData`) prior to further analyses. - Be aware of using the `^ERCC` regular expression for human data where the row names of the count matrix are gene symbols. An ERCC gene family actually exists in human annotation, so this would result in incorrect identification of genes as spike-in transcripts. This problem can be avoided by publishing count matrices with standard identifiers (e.g., Ensembl, Entrez). ## Incorporating cell-based annotation We load in the metadata for each library/cell from the `sdrf.txt` file. It is important to check that the rows of the metadata table are in the same order as the columns of the count matrix. Otherwise, incorrect metadata will be assigned to each cell. ```{r} metadata <- read.delim("E-MTAB-5522.sdrf.txt", check.names=FALSE, header=TRUE) m <- match(colnames(sce), metadata[["Source Name"]]) # Enforcing identical order. stopifnot(all(!is.na(m))) # Checking that nothing's missing. metadata <- metadata[m,] head(colnames(metadata)) ``` We only retain relevant metadata fields to avoid storing unnecessary information in the `colData` of the `SingleCellExperiment` object. In particular, we keep the plate of origin (i.e., `block`) and phenotype of each cell. The second field is relevant as all of the cells contain a _CBFB-MYH11_ oncogene, but the expression of this oncogene is only induced in a subset of the cells. ```{r} colData(sce)$Plate <- factor(metadata[["Factor Value[block]"]]) pheno <- metadata[["Factor Value[phenotype]"]] levels(pheno) <- c("induced", "control") colData(sce)$Oncogene <- pheno table(colData(sce)$Oncogene, colData(sce)$Plate) ``` ## Incorporating gene-based annotation Feature-counting tools typically report genes in terms of standard identifiers from Ensembl or Entrez. These identifiers are used as they are unambiguous and highly stable. However, they are difficult to interpret compared to the gene symbols which are more commonly used in the literature. Given the Ensembl identifiers, we obtain the corresponding gene symbols using annotation packages like `r Biocpkg("org.Mm.eg.db")`. ```{r} library(org.Mm.eg.db) symb <- mapIds(org.Mm.eg.db, keys=rownames(sce), keytype="ENSEMBL", column="SYMBOL") rowData(sce)$ENSEMBL <- rownames(sce) rowData(sce)$SYMBOL <- symb head(rowData(sce)) ``` It is often desirable to rename the row names of `sce` to the gene symbols, as these are easier to interpret. However, this requires some work to account for missing and duplicate symbols. The code below will replace missing symbols with the Ensembl identifier and concatenate duplicated symbols with the (unique) Ensembl identifiers. ```{r} new.names <- rowData(sce)$SYMBOL missing.name <- is.na(new.names) new.names[missing.name] <- rowData(sce)$ENSEMBL[missing.name] dup.name <- new.names %in% new.names[duplicated(new.names)] new.names[dup.name] <- paste0(new.names, "_", rowData(sce)$ENSEMBL)[dup.name] rownames(sce) <- new.names head(rownames(sce)) ``` We also determine the chromosomal location for each gene using the `r Biocpkg("TxDb.Mmusculus.UCSC.mm10.ensGene")` package. This will be useful later as several quality control metrics will be computed from rows corresponding to mitochondrial genes. ```{r} library(TxDb.Mmusculus.UCSC.mm10.ensGene) location <- mapIds(TxDb.Mmusculus.UCSC.mm10.ensGene, keys=rowData(sce)$ENSEMBL, column="CDSCHROM", keytype="GENEID") rowData(sce)$CHR <- location summary(location=="chrM") ``` Alternatively, annotation from BioMart resources can be directly added to the object using the `getBMFeatureAnnos` function from `r Biocpkg("scater")`. This may be more convenient than the approach shown above, but depends on an available internet connection to the BioMart databases. # Quality control on the cells ## Defining the quality control metrics Low-quality cells need to be removed to ensure that technical effects do not distort downstream analysis results. We use several quality control (QC) metrics: - The library size is defined as the total sum of counts across all features, i.e., genes and spike-in transcripts. Cells with small library sizes are of low quality as the RNA has not been efficiently captured (i.e., converted into cDNA and amplified) during library preparation. - The number of expressed features in each cell is defined as the number of features with non-zero counts for that cell. Any cell with very few expressed genes is likely to be of poor quality as the diverse transcript population has not been successfully captured. - The proportion of reads mapped to spike-in transcripts is calculated relative to the library size for each cell. High proportions are indicative of poor-quality cells, where endogenous RNA has been lost during processing (e.g., due to cell lysis or RNA degradation). The same amount of spike-in RNA to each cell, so an enrichment in spike-in counts is symptomatic of loss of endogenous RNA. - In the absence of spike-in transcripts, the proportion of reads mapped to genes in the mitochondrial genome can also be used. High proportions are indicative of poor-quality cells [@islam2014quantitative;@ilicic2016classification], possibly because of loss of cytoplasmic RNA from perforated cells. The reasoning is that mitochondria are larger than individual transcript molecules and less likely to escape through tears in the cell membrane. For each cell, we calculate these quality control metrics using the `calculateQCMetrics` function from the `r Biocpkg("scater")` package [@mccarthy2017scater]. These are stored in the row- and column-wise metadata of the `SingleCellExperiment` for future reference. ```{r} library(scater) mito <- which(rowData(sce)$CHR=="chrM") sce <- calculateQCMetrics(sce, feature_controls=list(Mt=mito)) head(colnames(colData(sce)), 10) ``` The distributions of these metrics are shown in Figure \@ref(fig:qcplot416b), stratified by oncogene induction status and plate of origin. The aim is to remove putative low-quality cells that have low library sizes, low numbers of expressed features, and high spike-in (or mitochondrial) proportions. ```{r qcplot416b, fig.wide=TRUE, fig.cap="Distributions of various QC metrics for all cells in the 416B dataset. This includes the library sizes, number of expressed genes, and proportion of reads mapped to spike-in transcripts or mitochondrial genes."} sce$PlateOnco <- paste0(sce$Oncogene, ".", sce$Plate) multiplot( plotColData(sce, y="total_counts", x="PlateOnco"), plotColData(sce, y="total_features", x="PlateOnco"), plotColData(sce, y="pct_counts_ERCC", x="PlateOnco"), plotColData(sce, y="pct_counts_Mt", x="PlateOnco"), cols=2) ``` It is also valuable to examine how the QC metrics behave with respect to each other (Figure \@ref(fig:qcbiplot416b)). Generally, they will be in rough agreement, i.e., cells with low total counts will also have low numbers of expressed features and high ERCC/mitochondrial proportions. Clear discrepancies may correspond to technical differences between batches of cells (see below) or genuine biological differences in RNA content. ```{r qcbiplot416b, fig.width=10, fig.asp=0.5, fig.cap="Behaviour of each QC metric compared to the total number of expressed features. Each point represents a cell in the 416B dataset."} par(mfrow=c(1,3)) plot(sce$total_features, sce$total_counts/1e6, xlab="Number of expressed genes", ylab="Library size (millions)") plot(sce$total_features, sce$pct_counts_ERCC, xlab="Number of expressed genes", ylab="ERCC proportion (%)") plot(sce$total_features, sce$pct_counts_Mt, xlab="Number of expressed genes", ylab="Mitochondrial proportion (%)") ``` ## Identifying outliers for each metric Picking a threshold for these metrics is not straightforward as their absolute values depend on the experimental protocol. For example, sequencing to greater depth will lead to more reads and more expressed features, regardless of the quality of the cells. Similarly, using more spike-in RNA in the protocol will result in higher spike-in proportions. To obtain an adaptive threshold, we assume that most of the dataset consists of high-quality cells, and identify cells that are outliers for the various QC metrics. Outliers are defined based on the median absolute deviation (MADs) from the median value of each metric across all cells. We remove cells with log-library sizes that are more than 3 MADs below the median log-library size. A log-transformation improves resolution at small values, especially when the MAD of the raw values is comparable to or greater than the median. We also remove cells where the log-transformed number of expressed genes is 3 MADs below the median value. ```{r} libsize.drop <- isOutlier(sce$total_counts, nmads=3, type="lower", log=TRUE, batch=sce$PlateOnco) feature.drop <- isOutlier(sce$total_features, nmads=3, type="lower", log=TRUE, batch=sce$PlateOnco) ``` The `batch=` argument ensures that outliers are identified _within_ each level of the specified plate/oncogene factor. This allows `isOutlier()` to accommodate systematic differences in the QC metrics across plates (Figure \@ref(fig:qcplot416b)), which can arise due to technical differences in processing (e.g., differences in sequencing depth) rather than any changes in quality. The same reasoning applies to the oncogene induction status, where induced cells may have naturally fewer expressed genes for biological reasons. Failing to account for these systematic differences would inflate the MAD estimate and compromise the removal of low-quality cells. We identify outliers for the proportion-based metrics in a similar manner. Here, no transformation is required as we are identifying large outliers, for which the distinction should be fairly clear on the raw scale. We do not need to use the mitochondrial proportions as we already have the spike-in proportions (which serve a similar purpose) for this dataset. This avoids potential issues arising from genuine differences in mitochondrial content between cell types that may confound outlier identification. ```{r} spike.drop <- isOutlier(sce$pct_counts_ERCC, nmads=3, type="higher", batch=sce$PlateOnco) ``` Subsetting by column will retain only the high-quality cells that pass each filter described above. We examine the number of cells removed by each filter as well as the total number of retained cells. Removal of a substantial proportion of cells (> 10%) may be indicative of an overall issue with data quality. ```{r} keep <- !(libsize.drop | feature.drop | spike.drop) data.frame(ByLibSize=sum(libsize.drop), ByFeature=sum(feature.drop), BySpike=sum(spike.drop), Remaining=sum(keep)) ``` We then subset the `SingleCellExperiment` object to retain only the putative high-quality cells. We also save the original object to file for later use. ```{r} sce$PassQC <- keep saveRDS(sce, file="416B_preQC.rds") sce <- sce[,keep] dim(sce) ``` **Comments from Aaron:** - See [this section](http://bioconductor.org/packages/devel/workflows/vignettes/simpleSingleCell/inst/doc/work-4-misc.html#assumptions-of-outlier-identification) for a more detailed discussion of the assumptions underlying the outlier-based detection of low-quality cells. # Classification of cell cycle phase We use the prediction method described by @scialdone2015computational to classify cells into cell cycle phases based on the gene expression data. Using a training dataset, the sign of the difference in expression between two genes was computed for each pair of genes. Pairs with changes in the sign across cell cycle phases were chosen as markers. Cells in a test dataset can then be classified into the appropriate phase, based on whether the observed sign for each marker pair is consistent with one phase or another. This approach is implemented in the `cyclone` function from the `r Biocpkg("scran")` package. The package contains a pre-trained set of marker pairs for mouse data, which we can load in the the `readRDS` function. We use the Ensembl identifiers for each gene in our dataset to match up with the names in the pre-trained set of gene pairs. ```{r} set.seed(100) library(scran) mm.pairs <- readRDS(system.file("exdata", "mouse_cycle_markers.rds", package="scran")) assignments <- cyclone(sce, mm.pairs, gene.names=rowData(sce)$ENSEMBL) ``` The `cyclone` result for each cell in the HSC dataset is shown in Figure \@ref(fig:phaseplot416b). Each cell is assigned a score for each phase, with a higher score corresponding to a higher probability that the cell is in that phase. We focus on the G1 and G2/M scores as these are the most informative for classification. ```{r phaseplot416b, message=FALSE, fig.cap="Cell cycle phase scores from applying the pair-based classifier on the 416B dataset. Each point represents a cell, plotted according to its scores for G1 and G2/M phases."} plot(assignments$score$G1, assignments$score$G2M, xlab="G1 score", ylab="G2/M score", pch=16) ``` Cells are classified as being in G1 phase if the G1 score is above 0.5 and greater than the G2/M score; in G2/M phase if the G2/M score is above 0.5 and greater than the G1 score; and in S phase if neither score is above 0.5. Here, the vast majority of cells are classified as being in G1 phase. We save these assignments into the `SingleCellExperiment` object for later use. ```{r} sce$phases <- assignments$phases table(sce$phases) ``` Pre-trained classifiers are available in `r Biocpkg("scran")` for human and mouse data. While the mouse classifier used here was trained on data from embryonic stem cells, it is still accurate for other cell types [@scialdone2015computational]. This may be due to the conservation of the transcriptional program associated with the cell cycle [@bertoli2013control;@conboy2007cell]. The pair-based method is also a non-parametric procedure that is robust to most technical differences between datasets. __Comments from Aaron:__ - To remove confounding effects due to cell cycle phase, we can filter the cells to only retain those in a particular phase (usually G1) for downstream analysis. Alternatively, if a non-negligible number of cells are in other phases, we can use the assigned phase as a blocking factor. This protects against cell cycle effects without discarding information, and will be discussed later in more detail. - The classifier may not be accurate for data that are substantially different from those used in the training set, e.g., due to the use of a different protocol. In such cases, users can construct a custom classifier from their own training data using the `sandbag` function. This will also be necessary for other model organisms where pre-trained classifiers are not available. - Do not filter out low-abundance genes before applying `cyclone`. Even if a gene is not expressed in *any* cell, it may still be useful for classification if it is phase-specific. Its lack of expression relative to other genes will still yield informative pairs, and filtering them out would reduce power. # Examining gene-level expression metrics ## Inspecting the most highly expressed genes We examine the identities of the most highly expressed genes (Figure \@ref(fig:topgene416b)). This should generally be dominated by constitutively expressed transcripts, such as those for ribosomal or mitochondrial proteins. The presence of other classes of features may be cause for concern if they are not consistent with expected biology. For example, a top set containing many spike-in transcripts suggests that too much spike-in RNA was added during library preparation, while the absence of ribosomal proteins and/or the presence of their pseudogenes are indicative of suboptimal alignment. ```{r topgene416b, fig.asp=1.2, fig.wide=TRUE, fig.cap="Percentage of total counts assigned to the top 50 most highly-abundant features in the 416B dataset. For each feature, each bar represents the percentage assigned to that feature for a single cell, while the circle represents the average across all cells. Bars are coloured by the total number of expressed features in each cell, while circles are coloured according to whether the feature is labelled as a control feature."} fontsize <- theme(axis.text=element_text(size=12), axis.title=element_text(size=16)) plotQC(sce, type = "highest-expression", n=50) + fontsize ``` ## Filtering out low-abundance genes Low-abundance genes are problematic as zero or near-zero counts do not contain much information for reliable statistical inference [@bourgon2010independent]. These genes typically do not provide enough evidence to reject the null hypothesis during testing, yet they still increase the severity of the multiple testing correction. In addition, the discreteness of the counts may interfere with statistical procedures, e.g., by compromising the accuracy of continuous approximations. Thus, low-abundance genes are often removed in many RNA-seq analysis pipelines before the application of downstream methods. The "optimal" choice of filtering strategy depends on the downstream application. A more aggressive filter is usually required to remove discreteness (e.g., for normalization) compared to that required for removing underpowered tests. For hypothesis testing, the filter statistic should also be independent of the test statistic under the null hypothesis. Thus, we (or the relevant function) will filter at each step as needed, rather than applying a single filter for the entire analysis. Several metrics can be used to define low-abundance genes. The most obvious is the average count for each gene, computed across all cells in the dataset. We calculate this using the `calcAverage()` function, which also performs some adjustment for library size differences between cells. We typically observe a peak of moderately expressed genes following a plateau of lowly expressed genes (Figure \@ref(fig:abhist416b)). ```{r abhist416b, fig.cap="Histogram of log-average counts for all genes in the 416B dataset."} ave.counts <- calcAverage(sce, use_size_factors=FALSE) hist(log10(ave.counts), breaks=100, main="", col="grey80", xlab=expression(Log[10]~"average count")) ``` A minimum threshold can be applied to this value to filter out genes that are lowly expressed. The example below demonstrates how we _could_ remove genes with average counts less than 1. The number of `TRUE` values in `demo.keep` corresponds to the number of retained rows/genes after filtering. ```{r} demo.keep <- ave.counts >= 1 filtered.sce <- sce[demo.keep,] summary(demo.keep) ``` We also examine the number of cells that express each gene. This is closely related to the average count for most genes, as expression in many cells will result in a higher average (Figure \@ref(fig:nexprshist416b)). Genes expressed in very few cells are often uninteresting as they are driven by amplification artifacts (though they may also also arise from rare populations). We could then remove genes that are expressed in fewer than _n_ cells. ```{r nexprshist416b, fig.cap="The number of cells expressing each gene in the 416B dataset, plotted against the log-average count. Intensity of colour corresponds to the number of genes at any given location."} num.cells <- nexprs(sce, byrow=TRUE) smoothScatter(log10(ave.counts), num.cells, ylab="Number of cells", xlab=expression(Log[10]~"average count")) ``` As mentioned above, we will apply these filters at each step rather than applying them globally by subsetting `sce`. This ensures that the most appropriate filter is used in each application. Nonetheless, we remove genes that are not expressed in any cell to reduce computational work in downstream steps. Such genes provide no information and would be removed by any filtering strategy. ```{r} to.keep <- num.cells > 0 sce <- sce[to.keep,] summary(to.keep) ``` # Normalization of cell-specific biases ## Using the deconvolution method to deal with zero counts Read counts are subject to differences in capture efficiency and sequencing depth between cells [@stegle2015computational]. Normalization is required to eliminate these cell-specific biases prior to downstream quantitative analyses. This is often done by assuming that most genes are not differentially expressed (DE) between cells. Any systematic difference in count size across the non-DE majority of genes between two cells is assumed to represent bias and is removed by scaling. More specifically, "size factors" are calculated that represent the extent to which counts should be scaled in each library. Size factors can be computed with several different approaches, e.g., using the `estimateSizeFactorsFromMatrix` function in the `r Biocpkg("DESeq2")` package [@anders2010differential;@love2014moderated], or with the `calcNormFactors` function [@robinson2010scaling] in the `r Biocpkg("edgeR")` package. However, single-cell data can be problematic for these bulk data-based methods due to the dominance of low and zero counts. To overcome this, we pool counts from many cells to increase the count size for accurate size factor estimation [@lun2016pooling]. Pool-based size factors are then "deconvolved" into cell-based factors for cell-specific normalization. ```{r} sce <- computeSumFactors(sce) summary(sizeFactors(sce)) ``` The size factors are well-correlated with the library sizes for all cells (Figure \@ref(fig:normplot416b)). This suggests that most of the systematic differences between cells are driven by differences in capture efficiency or sequencing depth. Any DE between cells would yield a non-linear trend between the total count and size factor, and/or increased scatter around the trend. We observe some evidence of this after oncogene induction, where the size factors after induction are systematically lower. This is consistent with composition biases [@robinson2010scaling] introduced by upregulation of genes after induction. ```{r normplot416b, fig.cap="Size factors from deconvolution, plotted against library sizes for all cells in the 416B dataset. Axes are shown on a log-scale. Wild-type cells are shown in black and oncogene-induced cells are shown in red."} plot(sce$total_counts/1e6, sizeFactors(sce), log="xy", xlab="Library size (millions)", ylab="Size factor", col=c("red", "black")[sce$Oncogene], pch=16) legend("bottomright", col=c("red", "black"), pch=16, cex=1.2, legend=levels(sce$Oncogene)) ``` __Comments from Aaron:__ - While the deconvolution approach is robust to the high frequency of zeroes in scRNA-seq data, it will eventually fail if too many counts are zero. This manifests as negative size factors, which are obviously nonsensical. To avoid this, the `computeSumFactors` function will automatically remove low-abundance genes prior to the calculation of size factors. Genes with a library size-adjusted average count below a specified threshold (`min.mean`) are ignored. - For read count data, the default value of 1 is usually satisfactory. For UMI data, counts are lower so a threshold of 0.1 is recommended. - While the library size-adjusted average is not entirely independent of the bias [@bourgon2010independent], this is a better filter statistic than the sample mean count. The latter would enrich for genes that are upregulated in cells with large library sizes, resulting in inflated size factor estimates for those cells. - Cell-based QC should always be performed prior to normalization, to remove cells with very low numbers of expressed genes. If this is not done, the `computeSumFactors` function may yield negative size factors for low-quality cells. - The `sizes` argument can be used to specify the number of pool sizes to use to compute the size factors. More `sizes` yields more precise estimates at the cost of some computational time and memory. In general, `sizes` should not be below 20 cells, to ensure that there are sufficient non-zero expression values in each pool. We also recommend that the total number of cells should be at least 100 for effective pooling. - For highly heterogeneous datasets, it is advisable to perform a rough clustering of the cells. This can be done with the `quickCluster` function and the results passed to `computeSumFactors` via the `cluster` argument. Cells in each cluster are normalized separately, and the size factors are rescaled to be comparable across clusters. This avoids the need to assume that most genes are non-DE across the entire population - only a non-DE majority is required between pairs of clusters. We demonstrate this approach later with a larger dataset, as there are not enough cells in the 416B dataset. ## Computing separate size factors for spike-in transcripts Size factors computed from the counts for endogenous genes are usually not appropriate for normalizing the counts for spike-in transcripts. Consider an experiment without library quantification, i.e., the amount of cDNA from each library is _not_ equalized prior to pooling and multiplexed sequencing. Here, cells containing more RNA have greater counts for endogenous genes and thus larger size factors to scale down those counts. However, the same amount of spike-in RNA is added to each cell during library preparation. This means that the counts for spike-in transcripts are not subject to the effects of RNA content. Attempting to normalize the spike-in counts with the gene-based size factors will lead to over-normalization and incorrect quantification of expression. Similar reasoning applies in cases where library quantification is performed. For a constant total amount of cDNA, any increases in endogenous RNA content will suppress the coverage of spike-in transcripts. As a result, the bias in the spike-in counts will be opposite to that captured by the gene-based size factor. To ensure normalization is performed correctly, we compute a separate set of size factors for the spike-in set. For each cell, the spike-in-specific size factor is defined as the total count across all transcripts in the spike-in set. This assumes that none of the spike-in transcripts are differentially expressed, which is reasonable given that the same amount and composition of spike-in RNA should have been added to each cell [@lun2017assessing]. (See below for a more detailed discussion on spike-in normalization.) These size factors are stored in a separate field of the `SingleCellExperiment` object by setting `general.use=FALSE` in `computeSpikeFactors`. This ensures that they will only be used with the spike-in transcripts but not the endogenous genes. ```{r} sce <- computeSpikeFactors(sce, type="ERCC", general.use=FALSE) ``` ## Applying the size factors to normalize gene expression The count data are used to compute normalized log-expression values for use in downstream analyses. Each value is defined as the log~2~-ratio of each count to the size factor for the corresponding cell, after adding a prior count of 1 to avoid undefined values at zero counts. Division by the size factor ensures that any cell-specific biases are removed. If spike-in-specific size factors are present in `sce`, they will be automatically applied to normalize the spike-in transcripts separately from the endogenous genes. ```{r} sce <- normalize(sce) ``` The log-transformation is useful as it means that any differences in the values directly represent log~2~-fold changes in expression between cells. This is usually more relevant than the absolute differences in coverage, which need to be interpreted in the context of the overall abundance. The log-transformation also provides some measure of variance stabilization [@law2014voom], so that high-abundance genes with large variances do not dominate downstream analyses. The computed values are stored as an `"logcounts"` matrix in addition to the other assay elements. ```{r, echo=FALSE, results="hide"} gc() ``` # Modelling the technical noise in gene expression ## Fitting a trend to the spike-in variances Variability in the observed expression values across genes can be driven by genuine biological heterogeneity or uninteresting technical noise. To distinguish between these two possibiltiies, we need to model the technical component of the variance of the expression values for each gene. We do so using the set of spike-in transcripts, which were added in the same quantity to each cell. Thus, the spike-in transcripts should exhibit no biological variability, i.e., any variance in their counts should be technical in origin. We use the `trendVar()` function to fit a mean-dependent trend to the variances of the log-expression values for the spike-in transcripts. We set `block=` to block on the plate of origin for each cell, to ensure that technical differences between plates do not inflate the variances. Given the mean abundance of a gene, the fitted value of the trend is then used as an estimate of the technical component for that gene. The biological component of the variance is finally calculated by subtracting the technical component from the total variance of each gene with the `decomposeVar` function. ```{r} var.fit <- trendVar(sce, parametric=TRUE, block=sce$Plate, loess.args=list(span=0.3)) var.out <- decomposeVar(sce, var.fit) head(var.out) ``` We visually inspect the trend to confirm that it corresponds to the spike-in variances (Figure \@ref(fig:hvgplot416b))). The wave-like shape is typical of the mean-variance trend for log-expression values. A linear increase in the variance is observed as the mean increases from zero, as larger variances are possible when the counts increase. At very high abundances, the effect of sampling noise decreases due to the law of large numbers, resulting in a decrease in the variance. ```{r hvgplot416b, fig.cap="Variance of normalized log-expression values for each gene in the 416B dataset, plotted against the mean log-expression. The blue line represents the mean-dependent trend fitted to the variances of the spike-in transcripts (red)."} plot(var.out$mean, var.out$total, pch=16, cex=0.6, xlab="Mean log-expression", ylab="Variance of log-expression") curve(var.fit$trend(x), col="dodgerblue", lwd=2, add=TRUE) cur.spike <- isSpike(sce) points(var.out$mean[cur.spike], var.out$total[cur.spike], col="red", pch=16) ``` We check the distribution of expression values for the genes with the largest biological components. This ensures that the variance estimate is not driven by one or two outlier cells (Figure \@ref(fig:hvgvioplot416b)). ```{r hvgvioplot416b, fig.cap="Violin plots of normalized log-expression values for the top 10 genes with the largest biological components in the 416B dataset. Each point represents the log-expression value in a single cell."} chosen.genes <- order(var.out$bio, decreasing=TRUE)[1:10] plotExpression(sce, features=rownames(var.out)[chosen.genes]) + fontsize ``` ## Choosing the parameters of the trend fit In practice, trend fitting is complicated by the small number of spike-in transcripts and the uneven distribution of their abundances. For low numbers of cells, these issues are exacerbated by the low precision of the variance estimates. Thus, some tuning of trend parameters such as `span` may be required to achieve a suitable fit - see `?trendVar` for more details. Setting `parametric=TRUE` is especially useful for modelling the expected wave-like shape of the mean-variance relationship. (This is not the default setting as it is not robust for arbitrary trend shapes.) The `trendVar` function will also automatically filter out low-abundance genes prior to trend fitting. This ensures that low-abundance genes do not interfere with the fit due to discreteness, which biases the estimate of variability of the variances around the trend; or due to the frequency of low-abundance genes, which reduces the sensitivity of span-based smoothing algorithms at higher abundances. The internal choice of filtering strategy involves a number of considerations: - Filtering uses the average of log-expression values rather than the (library size-adjusted) average count. The mean log-expression is independent of the variance estimate in a linear modelling framework [@bourgon2010independent], which ensures that the filter does not introduce spurious trends in the variances at the filter boundary. - The filter threshold is specified with the `min.mean` argument in `trendVar`. We use the default threshold of 0.1 (`min.mean`) based on the appearance of discrete patterns in the variance estimates for simulated Poisson-distributed counts. Lower thresholds of 0.001-0.01 may be more suitable for very sparse data, e.g., from droplet-based protocols. - The filter used in `trendVar` is _not_ applied in `decomposeVar` by default. Retention of all genes ensures that weak biological signal from rare subpopulations is not discarded. To apply the filter in `decomposeVar`, users should set `subset.row=rowMeans(logcounts(sce)) > 0.1` in the function call. Finally, users can set `use.spikes=FALSE` to fit a trend to the variances of the endogenous genes in the absence of spike-in transcripts. This requires some care in interpretation of the results, which will be discussed later. **Comments from Aaron:** - Negative biological components are often obtained from `decomposeVar`. These are intuitively meaningless as it is impossible for a gene to have total variance below technical noise. Nonetheless, such values occur due to imprecise estimation of the total variance, especially for low numbers of cells. - `decomposeVar` also yields _p_-values that can be used to define HVGs at a specific threshold for the false discovery rate (FDR). We will discuss this in more detail later, as formal detection of HVGs is not necessary for feature selection during data exploration. # Removing the batch effect As previously mentioned, the data were collected on two plates. Small uncontrollable differences in processing between plates can result in a batch effect, i.e., systematic differences in expression between cells on different plates. Such differences are not interesting and can be removed by applying the `removeBatchEffect()` function from the `r Biocpkg("limma")` package [@ritchie2015limma]. This removes the effect of the plate of origin while accounting for the (interesting) effect of oncogene induction. ```{r} library(limma) assay(sce, "corrected") <- removeBatchEffect(logcounts(sce), design=model.matrix(~sce$Oncogene), batch=sce$Plate) assayNames(sce) ``` Manual batch correction is necessary for downstream procedures that are not model-based, e.g., clustering and most forms of dimensionality reduction. However, if an analysis method can accept a design matrix, blocking on nuisance factors in the design matrix is preferable to using `removeBatchEffect()`. This is because the latter does not account for the loss of residual degrees of freedom, nor the uncertainty of estimation of the blocking factor terms. **Comments from Aaron:** - `removeBatchEffect()` performs a linear regression and sets the coefficients corresponding to the blocking factors to zero. This is effective provided that the population composition within each batch is known (and supplied as `design=`) or identical across batches. Such an assumption is reasonable for this dataset, involving a homogeneous cell line population on both plates. However, in most scRNA-seq applications, the factors of variation are not identical across batches and not known in advance. This motivates the use of more sophisticated batch correction methods such as `mnnCorrect()`. # Denoising expression values using PCA Once the technical noise is modelled, we can use principal components analysis (PCA) to remove random technical noise. Consider that each cell represents a point in the high-dimensional expression space, where the spread of points represents the total variance. PCA identifies axes in this space that capture as much of this variance as possible. Each axis is a principal component (PC), where any early PC will explain more of the variance than a later PC. We assume that biological processes involving co-regulated groups of genes will account for the most variance in the data. If this is the case, this process should be represented by one or more of the earlier PCs. In contrast, random technical noise affects each gene independently and will be represented by later PCs. The `denoisePCA()` function removes later PCs until the total discarded variance is equal to the sum of technical components for all genes used in the PCA. ```{r} sce <- denoisePCA(sce, technical=var.fit$trend, assay.type="corrected") dim(reducedDim(sce, "PCA")) ``` The function returns a `SingleCellExperiment` object containing the PC scores for each cell in the `reducedDims` slot. The aim is to eliminate technical noise and enrich for biological signal in the retained PCs. This improves resolution of the underlying biology during downstream procedures such as clustering. __Comments from Aaron:__ - `denoisePCA()` will only use genes that have positive biological components, i.e., variances greater than the fitted trend. This guarantees that the total technical variance to be discarded will not be greater than the total variance in the data. - No filtering is performed on abundance here, which ensures that PCs corresponding to rare subpopulations can still be detected. Discreteness is less of an issue as low-abundance genes also have lower variance, thus reducing their contribution to the PCA. - It is also possible to obtain a low-rank approximation of the original expression matrix, capturing the variance equivalent to the retained PCs. This is useful for denoising prior to downstream procedures that require gene-wise expression values. ```{r} sce2 <- denoisePCA(sce, technical=var.fit$trend, assay.type="corrected", value="lowrank") assayNames(sce2) ``` ```{r, echo=FALSE, results="hide"} rm(sce2) gc() ``` # Data exploration with dimensionality reduction We visualize the relationships between cells by constructing pairwise PCA plots for the first three components (Figure \@ref(fig:pcaplot416b-onco)). Cells with similar expression profiles should be located close together in the plot, while dissimilar cells should be far apart. In this case, we observe a clear separation of cells based on the oncogene induction status, consistent with the expected effects on the transcriptome. ```{r pcaplot416b-onco, fig.cap="Pairwise PCA plots of the first three PCs in the 416B dataset, constructed from normalized log-expression values of genes with positive biological components. Each point represents a cell, coloured according to oncogene induction status.", fig.width=9} plotReducedDim(sce, use_dimred="PCA", ncomponents=3, colour_by="Oncogene") + fontsize ``` By comparison, we observe no clear separation of cells by batch (Figure \@ref(fig:pcaplot416b-batch)). This indicates that our batch correction step using `removeBatchEffect()` was successful. ```{r pcaplot416b-batch, fig.cap="Pairwise PCA plots of the first three PCs in the 416B dataset, constructed from normalized log-expression values of genes with positive biological components. Each point represents a cell, coloured according to the plate of origin.", fig.width=9} plotReducedDim(sce, use_dimred="PCA", ncomponents=3, colour_by="Plate") + fontsize ``` Another widely used approach for dimensionality reduction is the _t_-stochastic neighbour embedding (_t_-SNE) method [@van2008visualizing]. _t_-SNE tends to work better than PCA for separating cells in more diverse populations. This is because the former can directly capture non-linear relationships in high-dimensional space, whereas the latter must represent them on linear axes. However, this improvement comes at the cost of more computational effort and requires the user to consider parameters such as the random seed and perplexity (see comments). We demonstrate the generation of _t_-SNE plots in Figure \@ref(fig:tsneplot416b), using the low-rank approximation of the data to take advantage of the denoising step. ```{r tsneplot416b, fig.cap="_t_-SNE plots constructed from the denoised PCs in the 416B dataset, using a range of perplexity values. Each point represents a cell, coloured according to its oncogene induction status. Bars represent the coordinates of the cells on each axis.", fig.width=15, fig.asp=0.5} run_args <- list(rand_seed=100, use_dimred="PCA") out5 <- plotTSNE(sce, run_args=c(run_args, perplexity=5), colour_by="Oncogene") + fontsize + ggtitle("Perplexity = 5") out10 <- plotTSNE(sce, run_args=c(run_args, perplexity=10), colour_by="Oncogene") + fontsize + ggtitle("Perplexity = 10") out20 <- plotTSNE(sce, run_args=c(run_args, perplexity=20), colour_by="Oncogene") + fontsize + ggtitle("Perplexity = 20") multiplot(out5, out10, out20, cols=3) ``` There are many other dimensionality reduction techniques that we do not consider here but could also be used, e.g., multidimensional scaling, diffusion maps. These have their own advantages and disadvantages -- for example, diffusion maps (see `plotDiffusionMap`) place cells along a continuous trajectory and are suited for visualizing graduated processes like differentiation [@angerer2016destiny]. __Comments from Aaron:__ - For each visualization method, additional cell-specific information can be incorporated into the colour, size or shape of each point. Here, cells are coloured by the total number of expressed features, which is strongly correlated with the first PC. We will discuss this in more detail in the next section. - For PCA, more components can be shown but these are usually less informative (and more difficult to interpret) as they explain less of the variance. - _t_-SNE is a stochastic method, so users should run the algorithm several times to ensure that the results are representative. Scripts should set a seed (via the `rand_seed` argument) to ensure that the chosen results are reproducible. It is also advisable to test different settings of the "perplexity" parameter as this will affect the distribution of points in the low-dimensional space. A good guide on how to interpret _t_-SNE plots can be found at http://distill.pub/2016/misread-tsne/. # Clustering cells into putative subpopulations ## Defining cell clusters from expression data The denoised log-expression values are used to cluster cells into putative subpopulations. Specifically, we perform hierarchical clustering on the Euclidean distances between cells, using Ward's criterion to minimize the total variance within each cluster. This yields a dendrogram that groups together cells with similar expression patterns across the chosen genes. ```{r} pcs <- reducedDim(sce, "PCA") my.dist <- dist(pcs) my.tree <- hclust(my.dist, method="ward.D2") ``` Clusters are explicitly defined by applying a dynamic tree cut [@langfelder2008defining] to the dendrogram. This exploits the shape of the branches in the dendrogram to refine the cluster definitions, and is more appropriate than `cutree` for complex dendrograms. Greater control of the empirical clusters can be obtained by manually specifying `cutHeight` in `cutreeDynamic`. We also set `minClusterSize` to a lower value than the default of 20, to avoid spurious aggregation of distant small clusters. ```{r} library(dynamicTreeCut) my.clusters <- unname(cutreeDynamic(my.tree, distM=as.matrix(my.dist), minClusterSize=10, verbose=0)) ``` We examine the distribution of cells in each cluster with respect to known factors. Each cluster is comprised of cells from both batches, indicating that the clustering is not driven by a batch effect. Differences in the composition of each cluster are observed with respect to `Oncogene`, consistent with a biological effect of oncogene induction. ```{r} table(my.clusters, sce$Plate) table(my.clusters, sce$Oncogene) ``` We visualize the cluster assignments for all cells on the _t_-SNE plot in Figure \@ref(fig:tsnecluster416b). Adjacent cells are generally assigned to the same cluster, indicating that the clustering procedure was applied correctly. ```{r tsnecluster416b, fig.cap="_t_-SNE plot of the denoised PCs of the 416B dataset. Each point represents a cell and is coloured according to the cluster identity to which it was assigned."} sce$cluster <- factor(my.clusters) plotTSNE(sce, run_args=list(use_dimred="PCA", perplexity=20, rand_seed=200), colour_by="cluster") + fontsize ``` We check the separatedness of the clusters using the silhouette width (Figure \@ref(fig:silhouette416b)). Cells with large positive silhouette widths are closer to other cells in the _same_ cluster than to cells in _different_ clusters. Conversely, cells with negative widths are closer to other clusters than to other cells in the cluster to which it was assigned. Each cluster would ideally contain many cells with large positive widths, indicating that it is well-separated from other clusters. ```{r silhouette416b, fig.cap="Barplot of silhouette widths for cells in each cluster. Each cluster is assigned a colour and cells with positive widths are coloured according to the colour of its assigned cluster. Any cell with a negative width is coloured according to the colour of the cluster that it is closest to. The average width for all cells in each cluster is shown, along with the average width for all cells in the dataset."} library(cluster) clust.col <- scater:::.get_palette("tableau10medium") # hidden scater colours sil <- silhouette(my.clusters, dist = my.dist) sil.cols <- clust.col[ifelse(sil[,3] > 0, sil[,1], sil[,2])] sil.cols <- sil.cols[order(-sil[,1], sil[,3])] plot(sil, main = paste(length(unique(my.clusters)), "clusters"), border=sil.cols, col=sil.cols, do.col.sort=FALSE) ``` Most cells in in Figure \@ref(fig:silhouette416b) have small positive widths, representing weak separation between clusters in the 416B dataset. This may be symptomatic of over-clustering where clusters that are clearly defined on oncogene induction status are further split into subsets that are less well separated. The silhouette width can be used to gauge the optimal parameter values (e.g., cut height, number of clusters) that maximize the separation between clusters. For example, we could vary the cut height or splitting depth in `cutreeDynamic` to maximize the average silhouette width across all cells. Nonetheless, we will proceed with the current clustering scheme in `my.clusters`, which provides reasonable partitions for further characterization of heterogeneity. ```{r echo=FALSE, results='hide'} gc() ``` **Comments from Aaron:** - An alternative clustering strategy is to use a matrix of distances derived from correlations (e.g., as in `quickCluster`). This is more robust to noise and normalization errors, but is also less sensitive to subtle changes in the expression profiles. - Both Ward's criterion and complete linkage yield spherical, compact clusters. In particular, complete linkage favours the formation of clusters with the same diameter. This may be desirable in some cases but is less appropriate when subpopulations differ in their variance. Thus, we typically use Ward's criterion for our initial clustering. Of course, it is simple (and recommended) to try other approaches provided that some assessment is performed, e.g., using the silhouette width. ## Detecting marker genes between clusters Once putative subpopulations are identified by clustering, we can identify marker genes for each cluster using the `findMarkers` function. This fits a linear model to the log-expression values for each gene using `r Biocpkg("limma")` [@ritchie2015limma]. The aim is to test for DE in each cluster compared to the others while blocking on uninteresting factors such as the plate of origin in `design`. The top DE genes are likely to be good candidate markers as they can effectively distinguish between cells in different clusters. ```{r} markers <- findMarkers(sce, my.clusters, block=sce$Plate) ``` For each cluster, the DE results of the relevant comparisons are consolidated into a single output table. This allows a set of marker genes to be easily defined by taking the top DE genes from each pairwise comparison between clusters. For example, to construct a marker set for cluster 1 from the top 10 genes of each comparison, one would filter `marker.set` to retain rows with `Top` less than or equal to 10. Other statistics are also reported for each gene, including the adjusted p-values (see below) and the log-fold changes relative to every other cluster. ```{r, echo=FALSE, results="hide"} old.digits <- options()$digits options(digits=3) ``` ```{r} marker.set <- markers[["1"]] head(marker.set, 10) ``` ```{r, echo=FALSE, results="hide"} options(digits=old.digits) ``` We save the list of candidate marker genes for further examination. ```{r} write.table(marker.set, file="416B_marker_1.tsv", sep="\t", quote=FALSE, row.names=FALSE) ``` We visualize the expression profiles of the top candidates to verify that the DE signature is robust (Figure \@ref(fig:heatmapmarker416b)). Most of the top markers have strong and consistent up- or downregulation in cells of cluster 1 compared to some or all of the other clusters. A cursory examination of the heatmap indicates that cluster 1 contains oncogene-induced cells with strong downregulation of DNA replication and cell cycle genes. This is consistent with the potential induction of senescence as an anti-tumorigenic response [@wajapeyee2010senescence]. A more comprehensive investigation of the function of these markers can be performed with gene set enrichment analyses, e.g., using `kegga` or `goana` from `r Biocpkg("limma")`. ```{r heatmapmarker416b, fig.width=10, fig.asp=0.8, fig.cap="Heatmap of mean-centred and normalized log-expression values for the top set of markers for cluster 1 in the 416B dataset. Column colours represent the cluster to which each cell is assigned, the plate of origin or the oncogene induction status of each cell, as indicated by the legend."} top.markers <- rownames(marker.set)[marker.set$Top <= 10] plotHeatmap(sce, features=top.markers, columns=order(sce$cluster), colour_columns_by=c("cluster", "Plate", "Oncogene"), cluster_cols=FALSE, center=TRUE, symmetric=TRUE, zlim=c(-5, 5)) ``` Many of the markers in Figure \@ref(fig:heatmapmarker416b) are not uniquely up- or downregulated in the chosen cluster. Testing for unique DE tends to be too stringent as it overlooks important genes that are expressed in two or more clusters. For example, in a mixed population of CD4^+^-only, CD8^+^-only, double-positive and double-negative T cells, neither _Cd4_ or _Cd8_ would be detected as subpopulation-specific markers because each gene is expressed in two subpopulations. With our approach, both of these genes will be picked up as candidate markers as they will be DE between at least one pair of subpopulations. A combination of markers can then be chosen to characterize a subpopulation, which is more flexible than trying to find uniquely DE genes. We strongly recommend selecting some markers for use in validation studies with an independent replicate population of cells. The aim is to identify a corresponding subset of cells that express the upregulated markers and do not express the downregulated markers. Ideally, a different technique for quantifying expression would also be used during validation, e.g., fluorescent _in situ_ hybridisation or quantitative PCR. This confirms that the subpopulation genuinely exists and is not an artifact of scRNA-seq or the computational analysis. __Comments from Aaron:__ - By setting `direction="up"`, `findMarkers` will only return genes that are upregulated in each cluster compared to the others. This is convenient in highly heterogeneous populations to focus on genes that can immediately identify each cluster. While lack of expression may also be informative, it is less useful for positive identification. - `findMarkers` can also be directed to find genes that are DE between the chosen cluster and _all_ other clusters. This should be done by setting `pval.type="all"`, which defines the p-value for each gene as the maximum value across all pairwise comparisons involving the chosen cluster. Combined with `direction="up"`, this can be used to identify unique markers for each cluster. However, this is sensitive to overclustering, as unique marker genes will no longer exist if a cluster is split into two smaller subclusters. - It must be stressed that the (adjusted) _p_-values computed here cannot be properly interpreted as measures of significance. This is because the clusters have been empirically identified from the data. `r Biocpkg("limma")` does not account for the uncertainty of clustering, which means that the _p_-values are much lower than they should be. This is not a concern in other analyses where the groups are pre-defined. - The `overlapExprs` function may also be useful here, to prioritize candidates where there is clear separation between the distributions of expression values of different clusters. This differs from `findMarkers`, which is primarily concerned with the log-fold changes in average expression between clusters. # Concluding remarks Once the basic analysis is completed, it is often useful to save the `SingleCellExperiment` object to file with the `saveRDS` function. The object can then be easily restored into new R sessions using the `readRDS` function. This allows further work to be conducted without having to repeat all of the processing steps described above. ```{r} saveRDS(file="416B_data.rds", sce) ``` A variety of methods are available to perform more complex analyses on the processed expression data. For example, cells can be ordered in pseudotime (e.g., for progress along a differentiation pathway) with `r Biocpkg("monocle")` [@trapnell2014dynamics] or `r Biocpkg("TSCAN")` [@ji2016tscan]; cell-state hierarchies can be characterized with the `r Biocpkg("sincell")` package [@julia2015sincell]; and oscillatory behaviour can be identified using `r Biocpkg("Oscope")` [@leng2015oscope]. HVGs can be used in gene set enrichment analyses to identify biological pathways and processes with heterogeneous activity, using packages designed for bulk data like `r Biocpkg("topGO")` or with dedicated single-cell methods like `r Biocpkg("scde")` [@fan2016characterizing]. Full descriptions of these analyses are outside the scope of this workflow, so interested users are advised to consult the relevant documentation. ```{r, echo=FALSE, results='hide'} gc() ``` All software packages used in this workflow are publicly available from the Comprehensive R Archive Network (https://cran.r-project.org) or the Bioconductor project (http://bioconductor.org). The specific version numbers of the packages used are shown below, along with the version of the R installation. ```{r} sessionInfo() ``` # References