As a SingleCellExperiment
-derived package,
MAST
can easily be inserted into workflows with packages
such as scran
, scater
, zinbwave
,
SCnorm
and others. Moreover, subclassing
SingleCellExperiment/SummarizedExperiment provides a flexible
abstraction for the assay
that contains the actual
expression data. It can use sparse Matrix
and HDF5 as
backends to save memory.
To use MAST with such packages, you just need to upcast the
SingleCellExperiment
to MAST’s subclass
SingleCellAssay
with the function
SceToSingleCellAssay
that handles the coercion and checks
the object for validity. Going the other direction, generally
SingleCellAssay
s should work in packages that use
SingleCellExperiment
, but if in doubt you could down-cast
with as(sca, 'SingleCellExperiment')
.
The main gotcha in all this is that some SingleCellExperiment-derived packages assume integer counts have been provided, while MAST assumes that log-transformed approximately scale-normalized data is provided. We find that MAST performs best with log-transformed, scale-normalized data that has been thresholded, such as log2(transcripts per million + 1).
We address this by:
SingleCellAssay
assay
containing such
putatively log-like dataIn what follows, we show an example of using scater
to
plot some QC metrics, SCnorm
to normalize data, and, and
conversion to a Seurat
object.
Scater McCarthy et al. (2017) is a package that provides functions for QC, normalization and visualization of single cell RNAseq data.
library(MAST)
knitr::opts_chunk$set(message = FALSE,error = FALSE,warning = FALSE)
data(maits, package='MAST')
unlog <- function(x) ceiling(2^x - 1)
sca_raw = FromMatrix(t(maits$expressionmat), maits$cdat, maits$fdat)
## Assuming data assay in position 1, with name et is log-transformed.
Here we make an object with assays counts
and
et
. By default, MAST
will operate on the
et
assay, but scran wants count-like data for some of its
QC. The et
data are log2 + 1 transcripts per million (TPM),
as output by RSEM.
We could specify the assay name at creation with
sca_raw = FromMatrix(list(logTPM = t(maits$expressionmat)), maits$cdat, maits$fdat)
or rename an object that contains appropriately transformed data with
assayNames(sca_raw) = c('logTPM', 'counts')
.
Before calling scater
functionality, you might pause to
consider if some features should belong in special control
sets, such as mitochrondial genes, or spike-ins.
Evidently some features were filtered, so not all cells contain 1 million counts.
sca_raw = runPCA(sca_raw, ncomponents=5, exprs_values = 'et')
plotReducedDim(sca_raw, dimred = 'PCA', colour_by = 'condition')
We can also run a PCA.
Since scater uses SingleCellExperiment
objects, the only
here consideration is making sure MAST
can find log-like
data, and possibly thresholding the data.
example_sce = mockSCE()
example_sce = logNormCounts(example_sce)
sca = SceToSingleCellAssay(example_sce)
Here we coerce example_sce
to be a SingleCellAssay
object.
## Fitted zlm on 2000 genes and 200 cells.
## Using BayesGLMlike ~ Treatment
We test for differential expression with regards to
Treatment
and explicitly indicate the
logcounts
slot will be used. Methods in MAST will operate
on the default slice returned by assay
, which has been
over-ridden to return log-like data: the default slice is the first
assay whose name, as given by assayNames(x)
, matches the
first element in the sequence
c('thresh', 'et', 'Et', 'lCount', 'logTPM', 'logCounts', 'logcounts')
.
So in the case of sca
, even if exprs_value
was
not specified, the logcounts
slot would have been used,
even though it comes second in assayNames(sca)
:
## [1] "counts" "logcounts"
library(Matrix)
sca_sparse = FromMatrix(
exprsArray = list(et = Matrix(t(maits$expressionmat), sparse = TRUE)),
cData = maits$cdat, fData = maits$fdat)
class(assay(sca_sparse))
## [1] "dgCMatrix"
## attr(,"package")
## [1] "Matrix"
regular_time = system.time(zlm( ~ condition, sca = sca_raw[1:100,]))
sparse_time = system.time(zlm( ~ condition, sca = sca_sparse[1:100,]))
There is no complication to providing a sparse matrix.
library(DelayedArray)
library(HDF5Array)
hd5_dat = as(t(maits$expressionmat), 'HDF5Array')
DelayedArray::seed(hd5_dat)
## An object of class "HDF5ArraySeed"
## Slot "filepath":
## [1] "/tmp/Rtmpcrptfc/HDF5Array_dump/auto288f4c127e3.h5"
##
## Slot "name":
## [1] "/HDF5ArrayAUTO00001"
##
## Slot "as_sparse":
## [1] FALSE
##
## Slot "type":
## [1] NA
##
## Slot "dim":
## [1] 16302 96
##
## Slot "chunkdim":
## [1] 13031 76
##
## Slot "first_val":
## [1] 0
Write sc_example_counts
to disk as an
HDF5Array
sca_delay = FromMatrix(
exprsArray = list(et = hd5_dat),
cData = maits$cdat, fData = maits$fdat)
class(assay(sca_delay))
## [1] "HDF5Matrix"
## attr(,"package")
## [1] "HDF5Array"
Nor is there a complication to using HDF5-backed stores.
knitr::kable(data.frame(method = c('Dense', 'Sparse', 'HDF5'), 'user time(s)' =c( regular_time[1], sparse_time[1], hd5_time[1]), check.names = FALSE))
method | user time(s) |
---|---|
Dense | 0.331 |
Sparse | 0.347 |
HDF5 | 10.142 |
Dense storage is generally fastest, followed by the sparse storage. HDF5 is often slowest, but if your data doesn’t fit in memory, you don’t really have any other choice. The linear models underlying MAST don’t have any special provision for big n data, and will tend to linearly (or worse) in the number of cells. So performance may be an issue even if they data do fit in memory.
library(zinbwave)
feature_var = apply(assay(sca_raw), 1, var)
sca_top500 = sca_raw[rank(-feature_var)<=500,]
zw = zinbwave(Y = sca_top500, X = '~1', which_assay = 'counts', K = 2, normalizedValues = TRUE)
Run zinbwave. To speed things, we take the top 500 most variable genes.
rd = data.frame(reducedDim(zw, 'PCA'), reducedDim(zw, 'zinbwave'), colData(zw))
GGally::ggpairs(rd, columns = c('PC1', 'PC2', 'W1', 'W2'), mapping = aes(color = condition))
colData(zw) = cbind(colData(zw), reducedDim(zw, 'zinbwave'))
zw = SceToSingleCellAssay(zw)
zz = zlm(~W1 + W2, sca = zw, exprs_values = 'et')
Fitted zlm with top 2 genes per contrast: ( log fold change Z-score )
primerid W1 W2
3002 11.2* -0.3 3458 12.3* -0.2 353 3.4 -3.9 7323 4.2 -4.1
primerid | W1 | W2 |
---|---|---|
3002 | 11.2* | -0.3 |
3458 | 12.3* | -0.2 |
353 | 3.4 | -3.9* |
7323 | 4.2 | -4.1* |
These are log-fold changes in the top few changes associated with factors 1 and 2.
library(dplyr)
library(data.table)
top5 = ss$datatable %>% filter(component=='logFC', contrast %like% 'W') %>% arrange(-abs(z)) %>% head(n=5) %>% left_join(rowData(zw) %>% as.data.table())
dat = zw[top5$primerid,] %>% as('data.table')
dat = dat[,!duplicated(colnames(dat)),with = FALSE]
plt = ggplot(dat, aes(x=W1, color = condition)) + geom_point() + facet_wrap(~symbolid)
Expression on “Et” scale (log2(TPM + 1))
Normalized expression from factor model