This vignette highlights some example workflows for performing differential expression in Seurat. For demonstration purposes, we will be using the interferon-beta stimulated human PBMCs dataset (ifnb) that is available via the SeuratData package.
library(Seurat) library(SeuratData) library(ggplot2) ifnb <- LoadData("ifnb")
The bulk of Seurat’s differential expression features can be accessed through the FindMarkers()
function. By default, Seurat performs differential expression (DE) testing based on the non-parametric Wilcoxon rank sum test. To test for DE genes between two specific groups of cells, specify the ident.1
and ident.2
parameters.
# Normalize the data ifnb <- NormalizeData(ifnb) # Find DE features between CD16 Mono and CD1 Mono Idents(ifnb) <- "seurat_annotations" monocyte.de.markers <- FindMarkers(ifnb, ident.1 = "CD16 Mono", ident.2 = "CD14 Mono") # view results head(monocyte.de.markers)
The results data frame has the following columns :
If the ident.2
parameter is omitted or set to NULL
, FindMarkers()
will test for differentially expressed features between the group specified by ident.1
and all other cells. Additionally, the parameter only.pos
can be set to TRUE
to only search for positive markers, i.e. features that are more highly expressed in the ident.1
group.
# Find differentially expressed features between CD14+ Monocytes and all other cells, only # search for positive markers monocyte.de.markers <- FindMarkers(ifnb, ident.1 = "CD16 Mono", ident.2 = NULL, only.pos = TRUE) # view results head(monocyte.de.markers)
Since this dataset contains treatment information (control versus stimulated with interferon-beta), we can also ask what genes change in different conditions for cells of the same type. First, we create a column in the meta.data
slot to hold both the cell type and treatment information and switch the current Idents
to that column. Then we use FindMarkers()
to find the genes that are different between control and stimulated CD14 monocytes.
ifnb$celltype.stim <- paste(ifnb$seurat_annotations, ifnb$stim, sep = "_") Idents(ifnb) <- "celltype.stim" mono.de <- FindMarkers(ifnb, ident.1 = "CD14 Mono_STIM", ident.2 = "CD14 Mono_CTRL", verbose = FALSE) head(mono.de, n = 10)
However, the p-values obtained from this analysis should be interpreted with caution, because these tests treat each cell as an independent replicate and ignore inherent correlations between cells originating from the same sample. Such analyses have been shown to find a large number of false positive associations, as has been demonstrated by Squair et al., 2021, Zimmerman et al., 2021, Junttila et al., 2022, and others. Below, we show how pseudobulking can be used to account for such within-sample correlation.
To pseudobulk, we will use AggregateExpression() to sum together gene counts of all the cells from the same sample for each cell type. This results in one gene expression profile per sample and cell type. We can then perform DE analysis using DESeq2 on the sample level. This treats the samples, rather than the individual cells, as independent observations.
First, we need to retrieve the sample information for each cell. This is not loaded in the metadata, so we will load it from the Github repo of the source data for the original paper.
Add sample information to the dataset
# load the inferred sample IDs of each cell ctrl <- read.table(url("https://raw.githubusercontent.com/yelabucsf/demuxlet_paper_code/master/fig3/ye1.ctrl.8.10.sm.best"), head = T, stringsAsFactors = F) stim <- read.table(url("https://raw.githubusercontent.com/yelabucsf/demuxlet_paper_code/master/fig3/ye2.stim.8.10.sm.best"), head = T, stringsAsFactors = F) info <- rbind(ctrl, stim) # rename the cell IDs by substituting the '-' into '.' info$BARCODE <- gsub(pattern = "\\-", replacement = "\\.", info$BARCODE) # only keep the cells with high-confidence sample ID info <- info[grep(pattern = "SNG", x = info$BEST), ] # remove cells with duplicated IDs in both ctrl and stim groups info <- info[!duplicated(info$BARCODE) & !duplicated(info$BARCODE, fromLast = T), ] # now add the sample IDs to ifnb rownames(info) <- info$BARCODE info <- info[, c("BEST"), drop = F] names(info) <- c("donor_id") ifnb <- AddMetaData(ifnb, metadata = info) # remove cells without donor IDs ifnb$donor_id[is.na(ifnb$donor_id)] <- "unknown" ifnb <- subset(ifnb, subset = donor_id != "unknown")
\
We can now perform pseudobulking (AggregateExpression()
) based on the donor IDs.
# pseudobulk the counts based on donor-condition-celltype pseudo_ifnb <- AggregateExpression(ifnb, assays = "RNA", return.seurat = T, group.by = c("stim", "donor_id", "seurat_annotations")) # each 'cell' is a donor-condition-celltype pseudobulk profile tail(Cells(pseudo_ifnb)) pseudo_ifnb$celltype.stim <- paste(pseudo_ifnb$seurat_annotations, pseudo_ifnb$stim, sep = "_")
Next, we perform DE testing on the pseudobulk level for CD14 monocytes, and compare it against the previous single-cell-level DE results.
Idents(pseudo_ifnb) <- "celltype.stim" bulk.mono.de <- FindMarkers(object = pseudo_ifnb, ident.1 = "CD14 Mono_STIM", ident.2 = "CD14 Mono_CTRL", test.use = "DESeq2") head(bulk.mono.de, n = 15) # compare the DE P-values between the single-cell level and the pseudobulk level results names(bulk.mono.de) <- paste0(names(bulk.mono.de), ".bulk") bulk.mono.de$gene <- rownames(bulk.mono.de) names(mono.de) <- paste0(names(mono.de), ".sc") mono.de$gene <- rownames(mono.de) merge_dat <- merge(mono.de, bulk.mono.de, by = "gene") merge_dat <- merge_dat[order(merge_dat$p_val.bulk), ] # Number of genes that are marginally significant in both; marginally significant only in bulk; and marginally significant only in single-cell common <- merge_dat$gene[which(merge_dat$p_val.bulk < 0.05 & merge_dat$p_val.sc < 0.05)] only_sc <- merge_dat$gene[which(merge_dat$p_val.bulk > 0.05 & merge_dat$p_val.sc < 0.05)] only_bulk <- merge_dat$gene[which(merge_dat$p_val.bulk < 0.05 & merge_dat$p_val.sc > 0.05)] print(paste0('# Common: ',length(common))) print(paste0('# Only in single-cell: ',length(only_sc))) print(paste0('# Only in bulk: ',length(only_bulk)))
We can see that while the p-values are correlated between the single-cell and pseudobulk data, the single-cell p-values are often smaller and suggest higher levels of significance. In particular, there are 3,519 genes with evidence of differential expression (prior to multiple hypothesis testing) in both analyses, 1,649 genes that only appear to be differentially expressed in the single-cell analysis, and just 204 genes that only appear to be differentially expressed in the bulk analysis. We can investigate these discrepancies using VlnPlot
.
First, we can examine the top genes that are differentially expressed in both analyses.
# create a new column to annotate sample-condition-celltype in the single-cell dataset ifnb$donor_id.stim <- paste0(ifnb$stim, "-", ifnb$donor_id) # generate violin plot Idents(ifnb) <- "celltype.stim" print(merge_dat[merge_dat$gene%in%common[1:2],c('gene','p_val.sc','p_val.bulk')]) VlnPlot(ifnb, features = common[1:2], idents = c("CD14 Mono_CTRL", "CD14 Mono_STIM"), group.by = "stim") VlnPlot(ifnb, features = common[1:2], idents = c("CD14 Mono_CTRL", "CD14 Mono_STIM"), group.by = "donor_id.stim", ncol = 1)
In both the pseudobulk and single-cell analyses, the p-values for these two genes are astronomically small. For both of these genes, when just comparing all stimulated CD4 monocytes to all control CD4 monocytes across samples, we see much higher expression in the stimulated cells. When breaking down these cells by sample, we continue to see consistently higher expression levels in the stimulated samples compared to the control samples; in other words, this finding is not driven by just one or two samples. Because of this consistency, we find this signal in both analyses.
By contrast, we can examine examples of genes that are only DE under the single-cell analysis.
print(merge_dat[merge_dat$gene%in%c('SRGN','HLA-DRA'),c('gene','p_val.sc','p_val.bulk')]) VlnPlot(ifnb, features <- c('SRGN','HLA-DRA'), idents = c("CD14 Mono_CTRL", "CD14 Mono_STIM"), group.by = "stim") VlnPlot(ifnb, features <- c('SRGN','HLA-DRA'), idents = c("CD14 Mono_CTRL", "CD14 Mono_STIM"), group.by = "donor_id.stim", ncol = 1)
Here, SRGN and HLA-DRA both have very small p-values in the single-cell analysis (on the orders of $10^{-21}$ and $10^{-9}$), but much larger p-values around 0.18 in the pseudobulk analysis. While there appears to be a difference between control and simulated cells when ignoring sample information, the signal is much weaker on the sample level, and we can see notable variability from sample to sample.
Finally, we also support many other DE tests using other methods. For completeness, the following tests are currently supported:
# Test for DE features using the MAST package Idents(ifnb) <- "seurat_annotations" head(FindMarkers(ifnb, ident.1 = "CD14 Mono", ident.2 = "CD16 Mono", test.use = "MAST"))
Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.