Workflow Overview




Introduction


Starting with labeled clustered data, for each labeled cluster, we can compare between case and control within that cluster to identify genes that are impacted by the experimental perturbation(s) for that cell-type or subtype.


After identifying what cell-types are likely present in our data, we can finally consider experimental conditions and use differential expression comparisons to address the biological question at hand for an experiment.

Objectives

  • Run “standard” differential expression comparisons with cells as replicates
  • Run “pseudobulk” differential expression comparisons with samples as replicates

We already introduced DE comparisons in the marker identification section of this workshop, but here we will show how to run comparisons between experimental conditions for each annotated cluster.

As a reminder, our data includes cells isolated from issue from day 0 (prior to injury) as controls, and days 7 and 21 post-injury as experimental conditions.



Differential Expression

For single-cell data there are generally two types approaches for running differential expression - either a cell-level or sample-level approach.

For cell-level comparisons, simpler statistical methods like a t-test or the Wilcoxon rank-sum test or single-cell specific methods that models cells individually like MAST can be used.

As mentioned earlier, many of the tools developed for bulk RNA-seq have been shown to have good performance for single-cell data, such as EdgeR or DESeq2, particularly when the count data is aggregated into sample-level “pseudobulk” values for each cluster source.

As discussed in the single-cell best practices book and in the Ouyang Lab’s marker gene identification materials, there are active benchmarking efforts and threshold considerations for single-cell data.

Standard comparisons

First we’ll run cell-level comparisons for our data for the pericyte cluster, starting with cells from the D21 vs D7 conditions. We’ll need to ensure our cells are labeled to reflect both the cluster and condition identities before running our comparison using FindMarker() and summarizing the results:

##### Day 3  - Differential Expression Analysis

# Make a day-celltype contrast --------------------------------------------

# set up combined label of day + celltype & assign as identities
geo_so$day.celltype = paste(geo_so$day, geo_so$cell_type, sep = '_')
# check labels
unique(geo_so$day.celltype)
x
Day0_Myofibroblast
Day0_Fibroblast
Day0_Endothelial
Day0_Dendritic Cell
Day0_Monocyte
Day0_Keratinocyte
Day0_B-cell
Day0_Platelet
Day0_Stem Cell
Day0_Pericyte
Day0_Muscle Satellite Cell
Day0_Muscle Cell
Day0_Regulatory T Cell
Day0_Infl. Macrophage
Day7_Endothelial
Day7_Monocyte
Day7_Fibroblast
Day7_Myofibroblast
Day7_Platelet
Day7_Dendritic Cell
Day7_Infl. Macrophage
Day7_Pericyte
Day7_Keratinocyte
Day7_Stem Cell
Day7_Muscle Satellite Cell
Day7_B-cell
Day7_Regulatory T Cell
Day7_Muscle Cell
Day21_Keratinocyte
Day21_Monocyte
Day21_Fibroblast
Day21_Dendritic Cell
Day21_Pericyte
Day21_Endothelial
Day21_Muscle Satellite Cell
Day21_Platelet
Day21_Regulatory T Cell
Day21_Myofibroblast
Day21_Stem Cell
Day21_Infl. Macrophage
Day21_Muscle Cell
Day21_B-cell
# Consider pericyte cluster D21 v D7 --------------------------------------

# Reset cell identities to the combined condition + cluster label
Idents(geo_so) = 'day.celltype'

# run comparison for D21 vs D0, using wilcoxon test
de_cell_pericyte_D21_vs_D7 = FindMarkers(
    object = geo_so,
    slot = 'data', test = 'wilcox',
    ident.1 = 'Day21_Pericyte', ident.2 = 'Day7_Pericyte')

head(de_cell_pericyte_D21_vs_D7)
                p_val avg_log2FC pct.1 pct.2     p_val_adj
Prelp    0.000000e+00  2.7679827 0.733 0.196  0.000000e+00
Fmod    1.787884e-302  2.3360379 0.893 0.484 3.659441e-298
Gm10076 4.480774e-301 -1.1937582 0.826 0.966 9.171249e-297
Tpt1    4.725577e-292  0.7972516 0.998 0.983 9.672311e-288
Cilp2   6.423561e-282  5.8555746 0.397 0.013 1.314775e-277
Wfdc1   2.177398e-262  6.5542085 0.350 0.005 4.456698e-258
# Add gene symmbols names and save ----------------------------------------

# Add rownames as a column for output
de_cell_pericyte_D21_vs_D7$gene = rownames(de_cell_pericyte_D21_vs_D7)

# save
write_csv(de_cell_pericyte_D21_vs_D7, 
          file = 'results/tables/de_standard_pericyte_D21_vs_D7.csv')

# summarize diffex results
table(de_cell_pericyte_D21_vs_D7$p_val_adj < 0.05 & 
        abs(de_cell_pericyte_D21_vs_D7$avg_log2FC) > 1.5)

FALSE  TRUE 
 9318   550 

In the first 3 lines of the above code block we can see the changes to the schematic:

Image: Schematic after setting the Idents().
Image: Schematic after setting the Idents().

Note - the avg_log2FC threshold of 1.5 we use here are quite stringent as the default log2FC threshold for the function is 0.25. However the default threshold corresponds to only a 19% difference in RNA levels, which is quite permissive.

If there is enough time - we can also compare between cells from the D7 and D0 conditions.

# Compare pericyte cluster D7 v D0 ----------------------------------------
de_cell_pericyte_D7_vs_D0 = FindMarkers(
    object = geo_so,
    slot = 'data', test = 'wilcox',
    ident.1 = 'Day7_Pericyte', ident.2 = 'Day0_Pericyte')

head(de_cell_pericyte_D7_vs_D0)
                 p_val avg_log2FC pct.1 pct.2     p_val_adj
Chad      0.000000e+00 -10.206432 0.002 0.507  0.000000e+00
Cilp2    1.800725e-304  -7.974229 0.013 0.754 3.685725e-300
Ptx4     2.058938e-281  -7.379806 0.005 0.551 4.214234e-277
Chodl    2.915716e-275  -7.299056 0.006 0.565 5.967887e-271
Myoc     6.985601e-156  -9.602538 0.002 0.275 1.429813e-151
Crispld1 1.677776e-138  -7.096563 0.010 0.420 3.434072e-134
# Add rownames for D7 v D0 results ----------------------------------------
de_cell_pericyte_D7_vs_D0$gene = rownames(de_cell_pericyte_D7_vs_D0)

# summarize results
table(de_cell_pericyte_D7_vs_D0$p_val_adj < 0.05 & 
        abs(de_cell_pericyte_D7_vs_D0$avg_log2FC) > 1.5)

FALSE  TRUE 
10966  1134 

This same approach can be extended to run pairwise comparisons between conditions for each annotated cluster of interest.

Pseudobulk comparisons

With advances in the technology as well as decreased sequencing costs allowing for larger scale single-cell experiments (that include replicates), along with a study by Squair et al (2021) that highlighted the possibility of inflated false discovery rates for the cell-level approaches since cells isolated from the same sample are unlikely to be statistically independent source the use of sample-level or “psuedobulk” can be advantageous.

We’ll run psuedobulk comparisons for our data for the monocyte cluster, starting with the D21 vs D0 conditions. We’ll need to generate the aggregated counts first (ensuring that we are grouping cells by replicate labels), before labeling the cells to reflect the cluster and condition. Then we will run our comparison using FindMarker() but specifying DESeq2 as our method before summarizing the results:

# Create pseudobulk object -------------------------------------------------
pseudo_catch_so = AggregateExpression(geo_so, assays = 'RNA', return.seurat = TRUE, group.by = c('cell_type', 'day', 'replicate'))

# Set up labels to use for comparisons & assign as cell identities
pseudo_catch_so$day.celltype = paste(pseudo_catch_so$day, pseudo_catch_so$cell_type, sep = '_')
Idents(pseudo_catch_so) = 'day.celltype'
# Run pseudobulk comparison between Day 21 and Day 0, using DESeq2 ----------
de_pseudo_pericyte_D21_vs_D7 = FindMarkers(
    object = pseudo_catch_so, 
    ident.1 = 'Day21_Pericyte', ident.2 = 'Day7_Pericyte', 
    test.use = 'DESeq2')

# Take a look at the table
head(de_pseudo_pericyte_D21_vs_D7)
               p_val avg_log2FC pct.1 pct.2     p_val_adj
Cilp2  1.818261e-247   4.939624     1     1 4.816392e-243
Wfdc1  7.925517e-157   5.035321     1     1 2.099390e-152
Cd55   2.295313e-145   1.954541     1     1 6.080055e-141
Ltbp4  6.844766e-116   1.445782     1     1 1.813110e-111
Prss23 5.654215e-105   1.047428     1     1 1.497745e-100
Lbp     3.574709e-96   1.684910     1     1  9.469048e-92
# Add genes and review pseudobulk results ----------------------------------

# Add rownames as a column for output
de_pseudo_pericyte_D21_vs_D7$gene = rownames(de_pseudo_pericyte_D21_vs_D7)

# save results
write_csv(de_pseudo_pericyte_D21_vs_D7,
          file = 'results/tables/de_pseudo_pericyte_D21_vs_D7.csv')

# look at results, using the same thresholds
table(de_pseudo_pericyte_D21_vs_D7$p_val_adj < 0.05 & 
        abs(de_pseudo_pericyte_D21_vs_D7$avg_log2FC) > 1.5)

FALSE  TRUE 
22810   932 

Since we’re working with pseudobulk data, unlike in the marker identification section, there is no percentage of cells expressing to need to represent so we can summarize our DE results with a volcano plot:

# Make a volcano plot of pseudobulk diffex results ------------------------
pseudo_pericyte_D21_vs_D7_volcano = ggplot(de_pseudo_pericyte_D21_vs_D7, aes(x = avg_log2FC, y = -log10(p_val))) + geom_point()

ggsave(filename = 'results/figures/volcano_de_pseudo_pericyte_D21_vs_D0.png', 
       plot = pseudo_pericyte_D21_vs_D7_volcano, width = 7, height = 7, units = 'in')

pseudo_pericyte_D21_vs_D7_volcano

Further examining DE results

We can also overlay the expression of interesting differentially expressed genes back onto our UMAP plots to highlight the localization and possible function, again using the FeaturePlot function.

# UMAP feature plot of Cd55 gene ------------------------------------------
FeaturePlot(geo_so, features = "Cd55", split.by = "day")

So we found Cd55 based on differential expression comparison in the Pericyte population between Day 7 and Day 21 but in looking at the Feature plot of expression, we also see high expression in a subset of cells on Day 0. This interesting, since according to Shin et al (2019), CD55 regulates bone mass in mice.

It also looks like there is a high percentage of expression in some of the other precursor populations on the top right of our plots, which is interesting and might suggest an interesting subpopulation that we might try to identify, particularly given the role of this gene and our interest in determining why abberant bone can form after injury.

Next steps

While looking at individual genes can reveal interesting patterns like in the case of Cd55, it’s not a very efficient process. So after running ‘standard’ and/or psuedobulk differential expression comparisons, we can use the same types of tools used downstream of bulk RNA-seq to interpret these results, such as GO term enrichment, KEGG pathway enrichment, and GSEA with mSigDB.

Save our progress

# Discard all ggplot objects currently in environment ---------------------
# Ok since we saved the plots as we went along
rm(list=names(which(unlist(eapply(.GlobalEnv, is.ggplot))))); 
gc()
            used   (Mb) gc trigger   (Mb)   max used   (Mb)
Ncells  10273784  548.7   17064398  911.4   17064398  911.4
Vcells 546851736 4172.2 1260050879 9613.5 1260046147 9613.4

We’ll save the scCATCH object. The Seurat object has not been changed in this module.

# Save Seurat object ------------------------------------------------------
saveRDS(geo_so, file = 'results/rdata/geo_so_sct_integrated_final.rds')

Downstream approaches

Beyond differential expression within clusters and , there are many other possible avenues of exploration and analysis for scRNA-seq data. Including, but not limited to:

We would recommend looking for studies in similar tissues or experimental questions and see what kind of approaches and tools were used to answer questions related to your biological question



Summary


Starting with labeled clustered data, for each labeled cluster, we can compare between case and control within that cluster to identify genes that are impacted by the experimental perturbation(s) for that cell-type or subtype.


Reviewing these results should allow us to identify genes of interest that are impacted by injury and in the context of the cell-types in which they are differentially expressed, formalize some hypotheses for what cell-types or biological processes might be contributing to aberrant bone formation.


These materials have been adapted and extended from materials listed above. These are open access materials distributed under the terms of the Creative Commons Attribution license (CC BY 4.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original author and source are credited.




Previous lesson Top of this lesson Workshop Wrap Up