Contents

Overview of the workflow

AUCell allows to identify cells with active gene sets (e.g. signatures, gene modules) in single-cell RNA-seq data. In brief, the workflow to run AUCell is based on three steps:

  1. Build the rankings

  2. Calculate the Area Under the Curve (AUC)

  3. Set the assignment thresholds

library(AUCell)
cells_rankings <- AUCell_buildRankings(exprMatrix)

genes <- c("gene1", "gene2", "gene3")
geneSets <- list(geneSet1=genes)
# geneSets <- GSEABase::GeneSet(genes, setName="geneSet1") # alternative
cells_AUC <- AUCell_calcAUC(geneSets, cells_rankings, aucMaxRank=nrow(cells_rankings)*0.05)

par(mfrow=c(3,3))
set.seed(123)
cells_assignment <- AUCell_exploreThresholds(cells_AUC, plotHist=TRUE, nCores=1, assign=TRUE)

In the following sections we explain and explore the output of each of these steps. The details of the methods behind AUCell are described in the following article:t

## Aibar et al. (2017) SCENIC: single-cell regulatory network inference and clustering. Nature Methods. doi: 10.1038/nmeth.4463

Please, also cite this article if you use AUCell in your research.

Before starting

Setup

By default, AUCell is installed only with the minimum dependencies. To run AUCell in parallel or run the examples in this tutorial, we recommend to install these packages:

if (!requireNamespace("BiocManager", quietly=TRUE))
    install.packages("BiocManager")
# To support paralell execution:
BiocManager::install(c("doMC", "doRNG","doSNOW"))
# For the main example:
BiocManager::install(c("mixtools", "GEOquery", "SummarizedExperiment"))
# For the examples in the follow-up section of the tutorial:
BiocManager::install(c("DT", "plotly", "NMF", "d3heatmap", "shiny", "rbokeh",
                       "dynamicTreeCut","R2HTML","Rtsne", "zoo"))

Some tips…

Help

At any time, remember you an access the help files for any function (i.e. ?AUCell_buildRankings). It is also possible to open this tutorial directly from R with the following commands:

# Explore tutorials in the web browser:
browseVignettes(package="AUCell") 

# Commnad line-based:
vignette(package="AUCell") # list
vignette("AUCell") # open

Report template

To generate an HTML report with your own data and comments, you can use the .Rmd file of this tutorial as template (i.e. copy the .Rmd file, and edit it as R notebook in RStudio).

vignetteFile <- paste(file.path(system.file('doc', package='AUCell')), "AUCell.Rmd", sep="/")
# Copy to edit as markdown
file.copy(vignetteFile, ".")
# Alternative: extract R code
Stangle(vignetteFile)

Running AUCell

0. Load scRNA-seq dataset and gene sets

The input data for AUCell are the expression matrix and the gene-sets.

Working directory

During this tutorial some plots and files are saved. To keep them tidy, we recommend to set the working directory to a new folder:

dir.create("AUCell_tutorial")
setwd("AUCell_tutorial") # or in the first code chunk (kntr options), if running as Notebook

Expression matrix

The expression matrix, from a single-cell RNA-seq dataset, should be formatted with the genes/features as rows and cells as columns.

Typically, this matrix will be loaded from a counts file, or from another R object. i.e.:

# i.e. Reading from a text file
exprMatrix <- read.table("myCountsMatrix.tsv")
exprMatrix <- as.matrix(exprMatrix)

# or using an expression set
exprMatrix <- exprs(myExpressionSet)

In this tutorial we use a dataset containing 3005 cells from mouse cortex and hippocampus. The dataset can be downloaded from GEO accession number GSE60361.

Zeisel, A., et al. (2015). Cell types in the mouse cortex and hippocampus revealed by single-cell RNA-seq. Science 347, 1138–1142. doi: 10.1126/science.aaa1934

# (This may take a few minutes)
library(GEOquery)
attemptsLeft <- 20
while(attemptsLeft>0)
{
  geoFile <- tryCatch(getGEOSuppFiles("GSE60361", makeDirectory=FALSE), error=identity) 
  if(methods::is(geoFile,"error")) 
  {
    attemptsLeft <- attemptsLeft-1
    Sys.sleep(5)
  }
  else
    attemptsLeft <- 0
}

gzFile <- grep(".txt.gz", basename(rownames(geoFile)), fixed=TRUE, value=TRUE)
message(gzFile)
txtFile <- gsub(".gz", "", gzFile, fixed=TRUE)
message(txtFile)
gunzip(filename=gzFile, destname=txtFile, remove=TRUE)

library(data.table)
geoData <- fread(txtFile, sep="\t")
geneNames <- unname(unlist(geoData[,1, with=FALSE]))
exprMatrix <- as.matrix(geoData[,-1, with=FALSE])
rm(geoData)
dim(exprMatrix)
rownames(exprMatrix) <- geneNames
exprMatrix[1:5,1:4]

# Remove file
file.remove(txtFile)

# Save for future use
mouseBrainExprMatrix <- exprMatrix
save(mouseBrainExprMatrix, file="exprMatrix_AUCellVignette_MouseBrain.RData")

To speed-up the execution of the tutorial, we will use only 5000 random genes from this dataset.

# load("exprMatrix_AUCellVignette_MouseBrain.RData")
set.seed(333)
exprMatrix <- mouseBrainExprMatrix[sample(rownames(mouseBrainExprMatrix), 5000),]

In this way, we will be using an expression matrix with (5000 gene and 3005 cells):

dim(exprMatrix)
## [1] 5000 3005

Gene sets

The other input AUCell needs is the ‘gene-sets’ or signatures to test on the cells. They can be provided in several formats (see ?AUCell_calcAUC for examples). e.g.:

library(GSEABase)
genes <- c("gene1", "gene2", "gene3")
geneSets <- GeneSet(genes, setName="geneSet1")
geneSets
## setName: geneSet1 
## geneIds: gene1, gene2, gene3 (total: 3)
## geneIdType: Null
## collectionType: Null 
## details: use 'details(object)'

In this example we will use gene-sets representing diferent cell types in the brain:

  1. Big gene signatures (> 1000 genes) for astrocytes, oligodendrocytes and neurons.

Cahoy, J.D., et al. (2008). A Transcriptome Database for Astrocytes, Neurons, and Oligodendrocytes: A New Resource for Understanding Brain Development and Function. J. Neurosci. 28, 264–278. doi: 10.1523/JNEUROSCI.4178-07.2008

  1. Big gene signature (> 500 genes) for microglia. Obtained by comparing bulk RNA-seq profiles of microglia (brain-resident macrophages) to macrophages from other tissues.

Lein, E.S., et al. (2007). Genome-wide atlas of gene expression in the adult mouse brain. Nature 445, 168–176. doi: 10.1038/nature05453

  1. Small gene signatures (<100 genes) for astrocytes and neurons.

Lavin, Y., et al. (2014) Tissue-Resident Macrophage Enhancer Landscapes Are Shaped by the Local Microenvironment. Cell 159, 1312–1326. doi: 10.1016/j.cell.2014.11.018

library(AUCell)
library(GSEABase)
gmtFile <- paste(file.path(system.file('examples', package='AUCell')), "geneSignatures.gmt", sep="/")
geneSets <- getGmt(gmtFile)

Let’s check how many of these genes are in the expression matrix:

geneSets <- subsetGeneSets(geneSets, rownames(exprMatrix)) 
cbind(nGenes(geneSets))
##                       [,1]
## Astrocyte_Cahoy        538
## Neuron_Cahoy           384
## Oligodendrocyte_Cahoy  477
## Astrocyte_Lein           7
## Neuron_Lein             13
## Microglia_lavin        165

To ease the interpretation of the tutorial, we will also add the gene-set size into its name:

geneSets <- setGeneSetNames(geneSets, newNames=paste(names(geneSets), " (", nGenes(geneSets) ,"g)", sep=""))

For the example, let’s also add a few sets of random genes and 100 genes expressed in many cells (i.e. housekeeping-like):

# Random
set.seed(321)
extraGeneSets <- c(
  GeneSet(sample(rownames(exprMatrix), 50), setName="Random (50g)"),
  GeneSet(sample(rownames(exprMatrix), 500), setName="Random (500g)"))

countsPerGene <- apply(exprMatrix, 1, function(x) sum(x>0))
# Housekeeping-like
extraGeneSets <- c(extraGeneSets,
                   GeneSet(sample(names(countsPerGene)[which(countsPerGene>quantile(countsPerGene, probs=.95))], 100), setName="HK-like (100g)"))

geneSets <- GeneSetCollection(c(geneSets,extraGeneSets))
names(geneSets)
## [1] "Astrocyte_Cahoy (538g)"       "Neuron_Cahoy (384g)"         
## [3] "Oligodendrocyte_Cahoy (477g)" "Astrocyte_Lein (7g)"         
## [5] "Neuron_Lein (13g)"            "Microglia_lavin (165g)"      
## [7] "Random (50g)"                 "Random (500g)"               
## [9] "HK-like (100g)"

Since we are using an expression matrix with only 5000 random genes, most of these genes are acutally not available in the dataset. However, AUCell is robust enough to use this ‘noisy’ data.

1. Build gene-expression rankings for each cell

The first step to calculate the enrichment of a signature is to create the “rankings”. These rankings are only an intermediate step to calculate the AUC, but they are kept as a separate step in the workflow in order to provide more flexibility (i.e. to save them for future analyses, to merge datasets, or process them by parts).

For each cell, the genes are ranked from highest to lowest value. The genes with same expression value are shuffled. Therefore, genes with expression ‘0’ are randomly sorted at the end of the ranking. It is important to check that most cells have at least the number of expressed/detected genes that are going to be used to calculate the AUC (aucMaxRank in calcAUC()). The histogram provided by AUCell_buildRankings() allows to quickly check this distribution. plotGeneCount(exprMatrix) allows to obtain only the plot before building the rankings.

Since the rankings are created individually for each cell, in principle, it is possible to merge cell-rankings from different datasets. However, the datasets should be similar in regards to their “sensitivity” (e.g. the number of genes detected in the cells of each datasets), and the genes they include (e.g. same gene IDs).

cells_rankings <- AUCell_buildRankings(exprMatrix, nCores=1, plotStats=TRUE)
## Quantiles for the number of genes detected by cell: 
## (Non-detected genes are shuffled at the end of the ranking. Keep it in mind when choosing the threshold for calculating the AUC).

##  min   1%   5%  10%  50% 100% 
##  191  270  369  445  929 2062
cells_rankings
## Ranking for 5000 genes (rows) and 3005 cells (columns).
## 
## Top-left corner of the ranking:
##                     cells
## genes                1772071015_C02 1772071017_G12 1772071017_A05
##   0610009B22Rik                2397           1136            708
##   0610009L18Rik                3024           4719           3461
##   0610010B08Rik_loc6           1914           2268           3952
##   0610011F06Rik                 325            857           1060
##   0610012H03Rik                3018           3164           2680
##   0610039K10Rik                2533           1818           2979
##                     cells
## genes                1772071014_B06 1772067065_H06
##   0610009B22Rik                 680           1650
##   0610009L18Rik                3713           2664
##   0610010B08Rik_loc6           2684           3219
##   0610011F06Rik                2185           1128
##   0610012H03Rik                4520           2180
##   0610039K10Rik                1819           2795
## 
## Quantiles for the number of genes detected by cell:
##  min   1%   5%  10%  50% 100% 
##  191  270  369  445  929 2062

The “rankings” can be seen as a new representation of the original dataset. Once they are calculated, they can be saved for future analyses.

save(cells_rankings, file="cells_rankings.RData")

2. Calculate enrichment for the gene signatures (AUC)

To determine whether the gene set is enriched at the top of the gene-ranking for each cell, AUCell uses the “Area Under the Curve” (AUC) of the recovery curve.

The function AUCell_calcAUC calculates this score, and returns a matrix with an AUC score for each gene-set in each cell.

cells_AUC <- AUCell_calcAUC(geneSets, cells_rankings)
save(cells_AUC, file="cells_AUC.RData")

In order to calculate the AUC, by default only the top 5% of the genes in the ranking are used (i.e. checks whether the genes in the gene-set or signature are within the top 5%). This allows faster execution on bigger datasets, and reduce the effect of the noise at the bottom of the ranking (e.g. where many genes might be tied at 0 counts). The percentage to take into account can be modified with the argument aucMaxRank. For datasets where most cells express many genes (e.g. a filtered dataset), or these have high expression values, it might be good to increase this threshold. Check the histogram provided by AUCell_buildRankings to get an estimation on where this threshold lies within the dataset.

3. Determine the cells with the given gene signatures or active gene sets

In summary: The AUC represents the proportion of expressed genes in the signature, and their relative expression value compared to the other genes within the cell. We can use this propperty to explore the population of cells that are present in the dataset according to the expression of the gene-set.

The AUC estimates the proportion of genes in the gene-set that are highly expressed in each cell. Cells expressing many genes from the gene-set will have higher AUC values than cells expressing fewer (i.e. compensating for housekeeping genes, or genes that are highly expressed in all the cells in the dataset). Since the AUC represents the proportion of expressed genes in the signature, we can use the relative AUCs across the cells to explore the population of cells that are present in the dataset according to the expression of the gene-set.

However, determining whether the signature is active (or not) in a given cell is not always trivial. The AUC is not an absolute value, but it depends on the the cell type (i.e. sell size, amount of transcripts), the specific dataset (i.e. sensitivity of the measures) and the gene-set. It is often not straight forward to obtain a pruned signature of clear marker genes that are completely “on” in the cell type of interest and off" in every other cell. In addition, at single-cell level, most genes are not expressed or detected at a constant level.

The ideal situation will be a bi-modal distribution, in which most cells in the dataset have a low “AUC” compared to a population of cells with a clearly higher value (i.e. see “Oligodendrocites” in the next figure). This is normally the case on gene sets that are active mostly in a population of cells with a good representation in the dataset (e.g. ~ 5-30% of cells in the dataset). Similar cases of “marker” gene sets but with different proportions of cells in the datasets are the “neurons” and “microglia” (see figure). When there are very few cells within the dataset, the distribution might look normal-like, but with some outliers to the higher end (e.g. microglia). While if the gene set is marker of a high percentage of cells in the dataset (i.e. neurons), the distribution might start approaching the look of a gene-set of housekeeping genes. As example, the ‘housekeeping’ gene-set in the figure includes genes that are detected in most cells in the dataset.

Note that the size of the gene-set will also affect the results. With smaller gene-genes (fewer genes), it is more likely to get cells with AUC = 0. While this is the case of the “perfect markers” it is also easier to get it by chance with smal datasets. (i.e. Random gene set with 50 genes in the figure). Bigger gene-sets (100-2k) can be more stable and easier to evaluate, as big random gene sets will approach the normal distibution.

To ease the exploration of the distributions, the function AUCell_exploreThresholds() automatically plots all the histograms and calculates several thresholds that could be used to consider a gene-set ‘active’ (returned in $aucThr). The distributions are plotted as dotted lines over the histogram and the corresponding thresholds as vertical bars in the matching color. The thicker vertical line indicates the threshold selected by default ($aucThr$selected): the highest value to reduce the false positives.

Note: This function makes use of package “mixtools” to explore the distributions. It is not essential, but we recommend to install it: if (!requireNamespace("BiocManager", quietly=TRUE)); BiocManager::install("mixtools") install.packages("BiocManager"); BiocManager::install("mixtools")

set.seed(123)
par(mfrow=c(3,3)) 
cells_assignment <- AUCell_exploreThresholds(cells_AUC, plotHist=TRUE, assign=TRUE) 

warningMsg <- sapply(cells_assignment, function(x) x$aucThr$comment)
warningMsg[which(warningMsg!="")]
##                                                                                                         Microglia_lavin (165g) 
##                                                              "The AUC might follow a normal distribution (random gene-set?). " 
##                                                                                                                  Random (500g) 
## "The AUC might follow a normal distribution (random gene-set?).  The global distribution overlaps the partial distributions. "

The thresholds calcuated for each gene set are stored in the $aucThr slot. For example, the thresholds suggested for the oligodendrocyte gene-set:

cells_assignment$Oligodendrocyte_Cahoy$aucThr$thresholds
##             threshold nCells
## Global_k1   0.2419241    739
## L_k2        0.2437017    733
## R_k3        0.1766730   1008
## minimumDens 0.2417192    740

To ease for the inclusion of AUCell in workflows (e.g. SCENIC), this function can also provide the list of cells with an AUC value over this threshold ($assignment). However, keep in mind that the threshold selection in the current version is not exhaustive, so we highly recommend to check the AUC histograms and manually select the threshold if needed.

To obtain the threshold selected automatically for a given gene set(e.g. Oligodendrocytes):

cells_assignment$Oligodendrocyte_Cahoy$aucThr$selected
## minimumDens 
##   0.2417192
# getThresholdSelected(cells_assignment)

Cells assigned at this threshold:

oligodencrocytesAssigned <- cells_assignment$Oligodendrocyte_Cahoy$assignment
length(oligodencrocytesAssigned)
## [1] 740
head(oligodencrocytesAssigned)
## [1] "1772067069_B02" "1772066077_G03" "1772066070_D08" "1772067076_A07"
## [5] "1772067057_G07" "1772067076_C07"

Plotting the AUC histogram of a specific gene set, and setting a new threshold:

geneSetName <- rownames(cells_AUC)[grep("Oligodendrocyte_Cahoy", rownames(cells_AUC))]
AUCell_plotHist(cells_AUC[geneSetName,], aucThr=0.25)
abline(v=0.25)

Assigning cells to this new threshold:

newSelectedCells <- names(which(getAUC(cells_AUC)[geneSetName,]>0.08))
length(newSelectedCells)
## [1] 3001
head(newSelectedCells)
## [1] "1772071015_C02" "1772071017_G12" "1772071017_A05" "1772071014_B06"
## [5] "1772067065_H06" "1772071017_E02"

Follow up examples

Exploring the cell-assignment (table & heatmap)

The cell assignment is stored in the $assignment slot. Here we show a few ideas on how they can be extracted and visualized.

Extract these cells for all the gene-sets and transform it into a table:

cellsAssigned <- lapply(cells_assignment, function(x) x$assignment)
assignmentTable <- reshape2::melt(cellsAssigned, value.name="cell")
colnames(assignmentTable)[2] <- "geneSet"
head(assignmentTable)
##             cell                geneSet
## 1 1772071015_A01 Astrocyte_Cahoy (538g)
## 2 1772066080_D10 Astrocyte_Cahoy (538g)
## 3 1772066099_C03 Astrocyte_Cahoy (538g)
## 4 1772071036_B05 Astrocyte_Cahoy (538g)
## 5 1772062109_E07 Astrocyte_Cahoy (538g)
## 6 1772067060_G06 Astrocyte_Cahoy (538g)

Convert into an incidence matrix and plot as a histogram:

assignmentMat <- table(assignmentTable[,"geneSet"], assignmentTable[,"cell"])
assignmentMat[,1:2]
##                               
##                                1772058148_A01 1772058148_A03
##   Astrocyte_Cahoy (538g)                    0              1
##   Astrocyte_Lein (7g)                       1              1
##   HK-like (100g)                            0              0
##   Microglia_lavin (165g)                    0              0
##   Neuron_Cahoy (384g)                       0              0
##   Neuron_Lein (13g)                         0              0
##   Oligodendrocyte_Cahoy (477g)              1              0
##   Random (50g)                              1              0
set.seed(123)
miniAssigMat <- assignmentMat[,sample(1:ncol(assignmentMat),100)]
library(NMF)
aheatmap(miniAssigMat, scale="none", color="black", legend=FALSE)

Some interactive options (output not shown):

library(d3heatmap)
d3heatmap(matrix(miniAssigMat), scale="none", colors=c("white", "black"))

library(DT)
datatable(assignmentTable, options = list(pageLength = 10), filter="top")

Explore cells/clusters based on the signature score

The AUC score can also be used to explore the output from previous clustering analyses (or vice-versa).

In this example, we will use the AUC obtained for the diferent signatures to color a t-SNE based previously run on the whole expression matrix (i.e. not the 5000 random genes).

# Load the tSNE (included in the package)
load(paste(file.path(system.file('examples', package='AUCell')), "cellsTsne.RData", sep="/"))
cellsTsne <- cellsTsne$Y
plot(cellsTsne, pch=16, cex=.3)

This t-SNE was created with this code (it takes a while to run):

load("exprMatrix_AUCellVignette_MouseBrain.RData")
sumByGene <- apply(mouseBrainExprMatrix, 1, sum)
exprMatSubset <- mouseBrainExprMatrix[which(sumByGene>0),]
logMatrix <- log2(exprMatSubset+1)

library(Rtsne)
set.seed(123)
cellsTsne <- Rtsne(t(logMatrix))
rownames(cellsTsne$Y) <- colnames(logMatrix)
colnames(cellsTsne$Y) <- c("tsne1", "tsne2")
save(cellsTsne, file="cellsTsne.RData")

This t-SNE can be colored based on the AUC scores. To highlight the cluster of cells that are more likely of the cell type according to the signatures, we will split the cells into the cells that pass the assignment threshold (colored in shades of pink-red), and the cells that don’t (colored in black-blue).

Of course, the origin of the signatures should also be kept in mind for the interpretation (for example, these signatures were obtained from bulk RNA-seq analyses). Also, running this tutorial only on 5000 genes probably introduced some extra noise.

For this example we have used the thresholds assigned automatically:

selectedThresholds <- getThresholdSelected(cells_assignment)
par(mfrow=c(2,3)) # Splits the plot into two rows and three columns
for(geneSetName in names(selectedThresholds))
{
  nBreaks <- 5 # Number of levels in the color palettes
  # Color palette for the cells that do not pass the threshold
  colorPal_Neg <- grDevices::colorRampPalette(c("black","blue", "skyblue"))(nBreaks)
  # Color palette for the cells that pass the threshold
  colorPal_Pos <- grDevices::colorRampPalette(c("pink", "magenta", "red"))(nBreaks)
  
  # Split cells according to their AUC value for the gene set
  passThreshold <- getAUC(cells_AUC)[geneSetName,] >  selectedThresholds[geneSetName]
  if(sum(passThreshold) >0 )
  {
    aucSplit <- split(getAUC(cells_AUC)[geneSetName,], passThreshold)
    
    # Assign cell color
    cellColor <- c(setNames(colorPal_Neg[cut(aucSplit[[1]], breaks=nBreaks)], names(aucSplit[[1]])), 
    setNames(colorPal_Pos[cut(aucSplit[[2]], breaks=nBreaks)], names(aucSplit[[2]])))
    
    # Plot
    plot(cellsTsne, main=geneSetName,
    sub="Pink/red cells pass the threshold",
    col=cellColor[rownames(cellsTsne)], pch=16) 
  }
}

This kind of plots can also be used to explore the assignment thresholds. i.e.:

selectedThresholds[2] <-  0.25
par(mfrow=c(2,3))
AUCell_plotTSNE(tSNE=cellsTsne, exprMat=exprMatrix, 
cellsAUC=cells_AUC[1:2,], thresholds=selectedThresholds)

Interactive threshold selection

To help select the thresholds, there is also an interactive Shiny app:

library(shiny); library(rbokeh)
exprMat <- log2(mouseBrainExprMatrix+1) # (back to the full matrix)

# Create app 
aucellApp <- AUCell_createViewerApp(auc=cells_AUC, thresholds=selectedThresholds, 
tSNE=cellsTsne, exprMat=exprMat)

# Run (the exact commands depend on the R settings, see Shiny's doc for help)
options(shiny.host="0.0.0.0") 
savedSelections <- runApp(aucellApp) 

# Other common settings:
# host = getOption("shiny.host", "127.0.0.1") 
# shinyApp(ui=aucellApp$ui, server=aucellApp$server)

# Optional: Visualize extra information about the cells (categorical variable)
cellInfoFile <- paste(file.path(system.file('examples', package='AUCell')), 
"mouseBrain_cellLabels.tsv", sep="/")
cellInfo <- read.table(cellInfoFile, row.names=1, header=TRUE, sep="\t")
head(cellInfo)

Another example for interactive plot (e.g. to save as html, no need to keep the server running):

geneSetName <- "Astrocyte_Cahoy (555g)"

library(rbokeh)
tSNE.df <- data.frame(cellsTsne, cell=rownames(cellsTsne))
figure() %>%
ly_points(tsne1, tsne2, data=tSNE.df, size=1, legend = FALSE,
hover=cell, color=getAUC(cells_AUC)[geneSetName,rownames(tSNE.df)]) %>%
set_palette(continuous_color = pal_gradient(c("lightgrey", "pink", "red")))

Why to use AUCell?

Comparison with mean

One of the most intuitive ways to evaluate the expression of a gene signature is to calculate the mean expression. However, calculating the average of the gene signature on the raw counts will lead to cells with more reads (either for technical or biological reasons) to have higher average values for most signatures. To reduce this effect, some kind of library-size normalization would be required. Since AUCell evaluates the dectection of the signatures on each cell individually, it automatically compensates for library-size and makes its application easier and independent of the units of the data and other normalizations applied (e.g. raw counts, TPM, UMI counts).

logMat <- log2(exprMatrix+2)
meanByGs <- t(sapply(geneSets, function(gs) colMeans(logMat[geneIds(gs),])))
rownames(meanByGs) <- names(geneSets)
colorPal <- grDevices::colorRampPalette(c("black", "red"))(nBreaks)
par(mfrow=c(3,3))
for(geneSetName in names(geneSets))
{
  cellColor <- setNames(colorPal[cut(meanByGs[geneSetName,], breaks=nBreaks)], names(meanByGs[geneSetName,]))
  plot(cellsTsne, main=geneSetName, axes=FALSE, xlab="", ylab="",
  sub="Expression mean",
  col=cellColor[rownames(cellsTsne)], pch=16)
}

AUCell_plotTSNE(tSNE=cellsTsne, exprMat=exprMatrix, plots = "AUC",
cellsAUC=cells_AUC[1:9,], thresholds=selectedThresholds)

nGenesPerCell <- apply(exprMatrix, 2, function(x) sum(x>0))
colorPal <- grDevices::colorRampPalette(c("darkgreen", "yellow","red"))
cellColorNgenes <- setNames(adjustcolor(colorPal(10), alpha.f=.8)[as.numeric(cut(nGenesPerCell,breaks=10, right=FALSE,include.lowest=TRUE))], names(nGenesPerCell))
plot(cellsTsne, axes=FALSE, xlab="", ylab="",
sub="Number of detected genes",
col=cellColorNgenes[rownames(cellsTsne)], pch=16)

How reliable is AUCell? (Confusion matrix)

When using AUCell to identify cell types, the reliability of the cells identified will depend on the signatures used, and the differences within the cell types in the dataset. In any case, AUCell is quite robust to noise, both in the data and in the gene-set.

This is the comparison of the cells identified with AUCell (this example) and the cell-types assigned in the initial publication:

# "Real" cell type (e.g. provided in the publication)
cellLabels <- paste(file.path(system.file('examples', package='AUCell')), "mouseBrain_cellLabels.tsv", sep="/")
cellLabels <- read.table(cellLabels, row.names=1, header=TRUE, sep="\t")
# Confusion matrix:
cellTypeNames <- unique(cellLabels[,"level1class"])
confMatrix <- t(sapply(cells_assignment[c(1,4,2,5,3,6:9)], 
function(x) table(cellLabels[x$assignment,])[cellTypeNames]))
colnames(confMatrix) <- cellTypeNames
confMatrix[which(is.na(confMatrix), arr.ind=TRUE)] <- 0
confMatrix
##                              interneurons pyramidal SS pyramidal CA1
## Astrocyte_Cahoy (538g)                  1            0             3
## Astrocyte_Lein (7g)                   262          314           826
## Neuron_Cahoy (384g)                   290          396           937
## Neuron_Lein (13g)                     290          399           936
## Oligodendrocyte_Cahoy (477g)            0            1             3
## Microglia_lavin (165g)                  0            0             0
## Random (50g)                          148          240           500
## Random (500g)                           0            0             0
## HK-like (100g)                        211          348           625
##                              oligodendrocytes microglia endothelial-mural
## Astrocyte_Cahoy (538g)                      7         5                13
## Astrocyte_Lein (7g)                       667        78               229
## Neuron_Cahoy (384g)                        65        11                43
## Neuron_Lein (13g)                          85        14                46
## Oligodendrocyte_Cahoy (477g)              727         3                 1
## Microglia_lavin (165g)                      1        10                 0
## Random (50g)                              583        57               107
## Random (500g)                               0         0                 0
## HK-like (100g)                             89         3                11
##                              astrocytes_ependymal
## Astrocyte_Cahoy (538g)                        189
## Astrocyte_Lein (7g)                           224
## Neuron_Cahoy (384g)                            34
## Neuron_Lein (13g)                              27
## Oligodendrocyte_Cahoy (477g)                    5
## Microglia_lavin (165g)                          0
## Random (50g)                                   77
## Random (500g)                                   0
## HK-like (100g)                                  5

Notes on interpretation:

  • Interneurons & pyramidal are “neurons”.

  • According to other publications that have used this dataset to evaluate new methods, a relevant group of cells marked as oligodendrocytes are likely doublets (i.e. two cells, for example a mix of an oligodendrocyte + another cell type).

sessionInfo

This is the output of sessionInfo() on the system on which this document was compiled:

date()
## [1] "Wed May 19 17:07:57 2021"
sessionInfo()
## R version 4.1.0 (2021-05-18)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 20.04.2 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.13-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.13-bioc/R/lib/libRlapack.so
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_GB              LC_COLLATE=C              
##  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
## 
## attached base packages:
## [1] stats4    parallel  stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] RColorBrewer_1.1-2   GEOquery_2.60.0      plotly_4.9.3        
##  [4] ggplot2_3.3.3        NMF_0.23.0           bigmemory_4.5.36    
##  [7] cluster_2.1.2        rngtools_1.5         pkgmaker_0.32.2     
## [10] registry_0.5-1       DT_0.18              data.table_1.14.0   
## [13] GSEABase_1.54.0      graph_1.70.0         annotate_1.70.0     
## [16] XML_3.99-0.6         AnnotationDbi_1.54.0 IRanges_2.26.0      
## [19] S4Vectors_0.30.0     Biobase_2.52.0       BiocGenerics_0.38.0 
## [22] AUCell_1.14.0        BiocStyle_2.20.0    
## 
## loaded via a namespace (and not attached):
##   [1] bigmemory.sri_0.1.3         colorspace_2.0-1           
##   [3] ellipsis_0.3.2              XVector_0.32.0             
##   [5] GenomicRanges_1.44.0        bit64_4.0.5                
##   [7] fansi_0.4.2                 xml2_1.3.2                 
##   [9] splines_4.1.0               codetools_0.2-18           
##  [11] R.methodsS3_1.8.1           doParallel_1.0.16          
##  [13] cachem_1.0.5                knitr_1.33                 
##  [15] jsonlite_1.7.2              gridBase_0.4-7             
##  [17] kernlab_0.9-29              png_0.1-7                  
##  [19] R.oo_1.24.0                 shiny_1.6.0                
##  [21] BiocManager_1.30.15         readr_1.4.0                
##  [23] compiler_4.1.0              httr_1.4.2                 
##  [25] assertthat_0.2.1            Matrix_1.3-3               
##  [27] fastmap_1.1.0               lazyeval_0.2.2             
##  [29] limma_3.48.0                later_1.2.0                
##  [31] htmltools_0.5.1.1           tools_4.1.0                
##  [33] gtable_0.3.0                glue_1.4.2                 
##  [35] GenomeInfoDbData_1.2.6      reshape2_1.4.4             
##  [37] dplyr_1.0.6                 Rcpp_1.0.6                 
##  [39] jquerylib_0.1.4             vctrs_0.3.8                
##  [41] Biostrings_2.60.0           iterators_1.0.13           
##  [43] xfun_0.23                   stringr_1.4.0              
##  [45] mime_0.10                   lifecycle_1.0.0            
##  [47] MASS_7.3-54                 zlibbioc_1.38.0            
##  [49] scales_1.1.1                hms_1.1.0                  
##  [51] promises_1.2.0.1            MatrixGenerics_1.4.0       
##  [53] SummarizedExperiment_1.22.0 curl_4.3.1                 
##  [55] yaml_2.2.1                  memoise_2.0.0              
##  [57] sass_0.4.0                  segmented_1.3-4            
##  [59] stringi_1.6.2               RSQLite_2.2.7              
##  [61] highr_0.9                   foreach_1.5.1              
##  [63] GenomeInfoDb_1.28.0         rlang_0.4.11               
##  [65] pkgconfig_2.0.3             matrixStats_0.58.0         
##  [67] bitops_1.0-7                evaluate_0.14              
##  [69] lattice_0.20-44             purrr_0.3.4                
##  [71] htmlwidgets_1.5.3           bit_4.0.4                  
##  [73] tidyselect_1.1.1            plyr_1.8.6                 
##  [75] magrittr_2.0.1              bookdown_0.22              
##  [77] R6_2.5.0                    magick_2.7.2               
##  [79] generics_0.1.0              DelayedArray_0.18.0        
##  [81] DBI_1.1.1                   pillar_1.6.1               
##  [83] withr_2.4.2                 mixtools_1.2.0             
##  [85] survival_3.2-11             KEGGREST_1.32.0            
##  [87] RCurl_1.98-1.3              tibble_3.1.2               
##  [89] crayon_1.4.1                utf8_1.2.1                 
##  [91] rmarkdown_2.8               grid_4.1.0                 
##  [93] blob_1.2.1                  digest_0.6.27              
##  [95] xtable_1.8-4                tidyr_1.1.3                
##  [97] httpuv_1.6.1                R.utils_2.10.1             
##  [99] munsell_0.5.0               viridisLite_0.4.0          
## [101] bslib_0.2.5.1