Chapter 1 Lun 416B cell line (Smart-seq2)

1.1 Introduction

The Lun et al. (2017) dataset contains two 96-well plates of 416B cells (an immortalized mouse myeloid progenitor cell line), processed using the Smart-seq2 protocol (Picelli et al. 2014). 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.

1.3 Quality control

We save an unfiltered copy of the SingleCellExperiment for later use.

Technically, 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. However, it probably doesn’t do any harm to include it anyway.

Distribution of each QC metric across cells in the 416B dataset, stratified by the plate of origin. Each point represents a cell and is colored according to whether that cell was discarded.

Figure 1.1: Distribution of each QC metric across cells in the 416B dataset, stratified by the plate of origin. Each point represents a cell and is colored according to whether that cell was discarded.

Percentage of mitochondrial reads in each cell in the 416B dataset, compared to the total count (left) or the percentage of spike-in reads (right). Each point represents a cell and is colored according to whether that cell was discarded.

Figure 1.2: Percentage of mitochondrial reads in each cell in the 416B dataset, compared to the total count (left) or the percentage of spike-in reads (right). Each point represents a cell and is colored according to whether that cell was discarded.

We also examine the number of cells removed for each reason.

##              low_lib_size            low_n_features   high_subsets_Mt_percent 
##                         5                         0                         2 
## high_altexps_ERCC_percent                   discard 
##                         2                         7

1.4 Normalization

No pre-clustering is performed here, as the dataset is small and all cells are derived from the same cell line anyway.

##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max. 
##   0.347   0.711   0.921   1.000   1.152   3.604

We see that the induced cells have size factors that are systematically shifted from the uninduced cells, consistent with the presence of a composition bias (Figure 1.3).

Relationship between the library size factors and the deconvolution size factors in the 416B dataset. Each cell is colored according to its oncogene induction status.

Figure 1.3: Relationship between the library size factors and the deconvolution size factors in the 416B dataset. Each cell is colored according to its oncogene induction status.

1.5 Variance modelling

We block on the plate of origin to minimize plate effects, and then we take the top 10% of genes with the largest biological components.

Per-gene variance as a function of the mean for the log-expression values in the 416B dataset. Each point represents a gene (black) with the mean-variance trend (blue) fitted to the spike-in transcripts (red). This was performed separately for each plate.

Figure 1.4: Per-gene variance as a function of the mean for the log-expression values in the 416B dataset. Each point represents a gene (black) with the mean-variance trend (blue) fitted to the spike-in transcripts (red). This was performed separately for each plate.

1.6 Batch correction

The composition of cells is expected to be the same across the two plates, hence the use of removeBatchEffect() rather than more complex methods. For larger datasets, consider using regressBatches() from the batchelor package.

1.7 Dimensionality reduction

We do not expect a great deal of heterogeneity in this dataset, so we only request 10 PCs. We use an exact SVD to avoid warnings from irlba about handling small datasets.

1.8 Clustering

We compare the clusters to the plate of origin. Each cluster is comprised of cells from both batches, indicating that the clustering is not driven by a batch effect.

##        Plate
## Cluster 20160113 20160325
##       1       40       38
##       2       37       32
##       3       10       14
##       4        6        8

We compare the clusters to the oncogene induction status. We observe differences in in the composition of each cluster, consistent with a biological effect of oncogene induction.

##        Oncogene
## Cluster induced CBFB-MYH11 oncogene expression wild type phenotype
##       1                                     78                   0
##       2                                      0                  69
##       3                                      1                  23
##       4                                     14                   0
Obligatory $t$-SNE plot of the 416B dataset, where each point represents a cell and is colored according to the assigned cluster.

Figure 1.5: Obligatory \(t\)-SNE plot of the 416B dataset, where each point represents a cell and is colored according to the assigned cluster.

Most cells have relatively small positive widths in Figure 1.6, indicating that the separation between clusters is weak. 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. Nonetheless, we will proceed with the current clustering scheme as it provides reasonable partitions for further characterization of heterogeneity.

Silhouette plot for the hierarchical clustering of the 416B dataset. Each bar represents the silhouette width for a cell and is colored according to the assigned cluster (if positive) or the closest cluster (if negative).

Figure 1.6: Silhouette plot for the hierarchical clustering of the 416B dataset. Each bar represents the silhouette width for a cell and is colored according to the assigned cluster (if positive) or the closest cluster (if negative).

1.9 Interpretation

## DataFrame with 10 rows and 7 columns
##             Top     p.value         FDR summary.logFC   logFC.2   logFC.3
##       <integer>   <numeric>   <numeric>     <numeric> <numeric> <numeric>
## Ccna2         1 9.85422e-67 4.59246e-62      -7.13310  -7.13310  -2.20632
## Cdca8         1 1.01449e-41 1.52514e-38      -7.26175  -6.00378  -2.03841
## Pirb          1 4.16555e-33 1.95516e-30       5.87820   5.28149   5.87820
## Cks1b         2 2.98233e-40 3.23229e-37      -6.43381  -6.43381  -4.15385
## Aurkb         2 2.41436e-64 5.62593e-60      -6.94063  -6.94063  -1.65534
## Myh11         2 1.28865e-46 3.75353e-43       4.38182   4.38182   4.29290
## Mcm6          3 1.15877e-28 3.69887e-26      -5.44558  -5.44558  -5.82130
## Cdca3         3 5.02047e-45 1.23144e-41      -6.22179  -6.22179  -2.10502
## Top2a         3 7.25965e-61 1.12776e-56      -7.07811  -7.07811  -2.39123
## Mcm2          4 1.50854e-33 7.98908e-31      -5.54197  -5.54197  -6.09178
##          logFC.4
##        <numeric>
## Ccna2 -7.3451052
## Cdca8 -7.2617478
## Pirb   0.0352849
## Cks1b -6.4385323
## Aurkb -6.4162126
## Myh11  0.9410499
## Mcm6  -3.5804973
## Cdca3 -7.0539510
## Top2a -6.8297343
## Mcm2  -3.8238103

We visualize the expression profiles of the top candidates in Figure 1.7 to verify that the DE signature is robust. 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 (Wajapeyee et al. 2010).

Heatmap of the top marker genes for cluster 1 in the 416B dataset, stratified by cluster. The plate of origin and oncogene induction status are also shown for each cell.

Figure 1.7: Heatmap of the top marker genes for cluster 1 in the 416B dataset, stratified by cluster. The plate of origin and oncogene induction status are also shown for each cell.

Session Info

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_US.UTF-8        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] parallel  stats4    stats     graphics  grDevices utils     datasets 
[8] methods   base     

other attached packages:
 [1] cluster_2.1.2               dynamicTreeCut_1.63-1      
 [3] limma_3.48.0                scran_1.20.0               
 [5] scater_1.20.0               ggplot2_3.3.3              
 [7] scuttle_1.2.0               AnnotationHub_3.0.0        
 [9] BiocFileCache_2.0.0         dbplyr_2.1.1               
[11] ensembldb_2.16.0            AnnotationFilter_1.16.0    
[13] GenomicFeatures_1.44.0      AnnotationDbi_1.54.0       
[15] scRNAseq_2.6.0              SingleCellExperiment_1.14.0
[17] SummarizedExperiment_1.22.0 Biobase_2.52.0             
[19] GenomicRanges_1.44.0        GenomeInfoDb_1.28.0        
[21] IRanges_2.26.0              S4Vectors_0.30.0           
[23] BiocGenerics_0.38.0         MatrixGenerics_1.4.0       
[25] matrixStats_0.58.0          BiocStyle_2.20.0           
[27] rebook_1.2.0               

loaded via a namespace (and not attached):
  [1] igraph_1.2.6                  lazyeval_0.2.2               
  [3] BiocParallel_1.26.0           digest_0.6.27                
  [5] htmltools_0.5.1.1             viridis_0.6.1                
  [7] fansi_0.4.2                   magrittr_2.0.1               
  [9] memoise_2.0.0                 ScaledMatrix_1.0.0           
 [11] Biostrings_2.60.0             prettyunits_1.1.1            
 [13] colorspace_2.0-1              blob_1.2.1                   
 [15] rappdirs_0.3.3                xfun_0.23                    
 [17] dplyr_1.0.6                   crayon_1.4.1                 
 [19] RCurl_1.98-1.3                jsonlite_1.7.2               
 [21] graph_1.70.0                  glue_1.4.2                   
 [23] gtable_0.3.0                  zlibbioc_1.38.0              
 [25] XVector_0.32.0                DelayedArray_0.18.0          
 [27] BiocSingular_1.8.0            scales_1.1.1                 
 [29] pheatmap_1.0.12               edgeR_3.34.0                 
 [31] DBI_1.1.1                     Rcpp_1.0.6                   
 [33] viridisLite_0.4.0             xtable_1.8-4                 
 [35] progress_1.2.2                dqrng_0.3.0                  
 [37] bit_4.0.4                     rsvd_1.0.5                   
 [39] metapod_1.0.0                 httr_1.4.2                   
 [41] RColorBrewer_1.1-2            dir.expiry_1.0.0             
 [43] ellipsis_0.3.2                pkgconfig_2.0.3              
 [45] XML_3.99-0.6                  farver_2.1.0                 
 [47] CodeDepends_0.6.5             sass_0.4.0                   
 [49] locfit_1.5-9.4                utf8_1.2.1                   
 [51] tidyselect_1.1.1              labeling_0.4.2               
 [53] rlang_0.4.11                  later_1.2.0                  
 [55] munsell_0.5.0                 BiocVersion_3.13.1           
 [57] tools_4.1.0                   cachem_1.0.5                 
 [59] generics_0.1.0                RSQLite_2.2.7                
 [61] ExperimentHub_2.0.0           evaluate_0.14                
 [63] stringr_1.4.0                 fastmap_1.1.0                
 [65] yaml_2.2.1                    knitr_1.33                   
 [67] bit64_4.0.5                   purrr_0.3.4                  
 [69] KEGGREST_1.32.0               sparseMatrixStats_1.4.0      
 [71] mime_0.10                     biomaRt_2.48.0               
 [73] compiler_4.1.0                beeswarm_0.3.1               
 [75] filelock_1.0.2                curl_4.3.1                   
 [77] png_0.1-7                     interactiveDisplayBase_1.30.0
 [79] statmod_1.4.36                tibble_3.1.2                 
 [81] bslib_0.2.5.1                 stringi_1.6.2                
 [83] highr_0.9                     bluster_1.2.0                
 [85] lattice_0.20-44               ProtGenerics_1.24.0          
 [87] Matrix_1.3-3                  vctrs_0.3.8                  
 [89] pillar_1.6.1                  lifecycle_1.0.0              
 [91] BiocManager_1.30.15           jquerylib_0.1.4              
 [93] BiocNeighbors_1.10.0          cowplot_1.1.1                
 [95] bitops_1.0-7                  irlba_2.3.3                  
 [97] httpuv_1.6.1                  rtracklayer_1.52.0           
 [99] R6_2.5.0                      BiocIO_1.2.0                 
[101] bookdown_0.22                 promises_1.2.0.1             
[103] gridExtra_2.3                 vipor_0.4.5                  
[105] codetools_0.2-18              assertthat_0.2.1             
[107] rjson_0.2.20                  withr_2.4.2                  
[109] GenomicAlignments_1.28.0      Rsamtools_2.8.0              
[111] GenomeInfoDbData_1.2.6        hms_1.1.0                    
[113] grid_4.1.0                    beachmat_2.8.0               
[115] rmarkdown_2.8                 DelayedMatrixStats_1.14.0    
[117] Rtsne_0.15                    shiny_1.6.0                  
[119] ggbeeswarm_0.6.0              restfulr_0.0.13              

References

Lun, A. T. L., F. J. Calero-Nieto, L. Haim-Vilmovsky, B. Gottgens, and J. C. Marioni. 2017. “Assessing the reliability of spike-in normalization for analyses of single-cell RNA sequencing data.” Genome Res. 27 (11): 1795–1806.

Picelli, S., O. R. Faridani, A. K. Bjorklund, G. Winberg, S. Sagasser, and R. Sandberg. 2014. “Full-length RNA-seq from single cells using Smart-seq2.” Nat Protoc 9 (1): 171–81.

Wajapeyee, N., S. Z. Wang, R. W. Serra, P. D. Solomon, A. Nagarajan, X. Zhu, and M. R. Green. 2010. “Senescence induction in human fibroblasts and hematopoietic progenitors by leukemogenic fusion proteins.” Blood 115 (24): 5057–60.