scTGIFscTGIF 1.6.0
Here, we explain the concept of scTGIF. The analysis of single-cell RNA-Seq (scRNA-Seq) has a potential difficult problem; which data corresponds to what kind of cell type is not known a priori.
Therefore, at the start point of the data analysis of the scRNA-Seq dataset, each cell is “not colored” (unannotated) (Figure 1). There some approaches to support users to infer the cell types such as (1) Known marker gene expression, (2) BLAST-like gene expression comparison with reference DB, (3) differentially expressed genes (DEGs) and over-representative analysis (ORA) (scRNA-tools).
The first approach might be the most popular method, but this task is based on the expert knowledge about the cell types, and not always general-purpose. The second approach is easy and scalable, but still limited when the cell type is not known or still not measured by the other research organization. The third approach can perhaps be used in any situation but ambiguous and time-consuming task; this task is based on the cluster label and the true cluster structure, which is not known and some DEG methods have to be performed in each cluster, but recent scRNA-Seq dataset has tens to hundreds of cell types. Besides, a scRNA-Seq dataset can have low-quality cells and artifacts (e.g. doublet) but it is hard to distinguish from real cell data. Therefore, in actual data analytical situation, laborious trial-and-error cycle along with the change of cellular label cannot be evitable (Figure 1).
scTGIF is developed to reduce this trial-and-error cycle; This tool directly connects the unannotated cells and related gene function. Since this tool does not use reference DB, marker gene list, and cluster label can be used in any situation without expert knowledge and is not influenced by the change of cellular label.
Figure 1: Concept of scTGIF
In scTGIF, three data is required; the gene expression matrix, 2D coordinates of the cells (e.g. t-SNE, UMAP), and geneset of MSigDB. Firstly, the 2D coordinates are segmented as 50-by-50 grids, and gene expression is summarized in each grid level (X1). Next, the correspondence between genes and the related gene functions are summarized as gene-by-function matrix (X2). Here, we support only common genes are used in X1 and X2. Performing joint non-negative matrix factorization (jNMF) algorithm, which is implemented in nnTensor, the shared latent variables (W) with the two matrices are estimated.
Figure 2: Joint NMF
By this algorithm, a grid set and corresponding gene functions are paired. Lower-dimension (D)-by-Grid matrix H1 works as attention maps to help users to pay attention the grids, and D-by-Function matrix H2 shows the gene function enriched in the grids.
Figure 3: H1 and H2 matrices
scTGIF also supports some QC metrics to distinguish low-quality cells and artifacts from real cellular data.
To demonstrate the usage of scTGIF, we prepared a testdata of distal lung epithelium.
library("scTGIF")
library("SingleCellExperiment")
library("GSEABase")
library("msigdbr")
data("DistalLungEpithelium")
data("pca.DistalLungEpithelium")
data("label.DistalLungEpithelium")Although this data is still annotated and the cell type label is provided, scTGIF does not rely on this information.
par(ask=FALSE)
plot(pca.DistalLungEpithelium, col=label.DistalLungEpithelium, pch=16,
    main="Distal lung epithelium dataset", xlab="PCA1", ylab="PCA2", bty="n")
text(0.1, 0.05, "AT1", col="#FF7F00", cex=2)
text(0.07, -0.15, "AT2", col="#E41A1C", cex=2)
text(0.13, -0.04, "BP", col="#A65628", cex=2)
text(0.125, -0.15, "Clara", col="#377EB8", cex=2)
text(0.09, -0.2, "Cilliated", col="#4DAF4A", cex=2)To combine with the gene expression and the related gene function, we suppose the gene function data is summarized as the object of GSEABase. This data is directly downloadable from MSigDB and can be imported like gmt <- GSEABase::getGmt(“/YOURPATH/h.all.v6.0.entrez.gmt”)
Note that scTGIF only supports NCBI Gene IDs (Entrez IDs) for now. When the scRNA-Seq is not about human, the situation is more complicated. Here, we use msigdbr package to retrieve the mouse MSigDB genesets like below.
m_df = msigdbr(species = "Mus musculus",
    category = "H")[, c("gs_name", "entrez_gene")]
hallmark = unique(m_df$gs_name)
gsc <- lapply(hallmark, function(h){
    target = which(m_df$gs_name == h)
    geneIds = unique(as.character(m_df$entrez_gene[target]))
    GeneSet(setName=h, geneIds)
})
gmt = GeneSetCollection(gsc)
gmt = gmt[1:10] # Reduced for this demoNext, the data matrix is converted to the object of SingleCellExperiment package, and the 2D coordinates are registered as the reducedDims slot.
sce <- SingleCellExperiment(assays = list(counts = DistalLungEpithelium))
reducedDims(sce) <- SimpleList(PCA=pca.DistalLungEpithelium)Although the default mode of scTGIF use count slot as
the input matrix,
the normalized gene expression data can also be specified.
In such a case, we recommend using normcounts slot to register the data.
CPMED <- function(input){
    libsize <- colSums(input)
    median(libsize) * t(t(input) / libsize)
}
normcounts(sce) <- log10(CPMED(counts(sce)) + 1)After the registration of the data in sce,
settingTGIF will work like below.
settingTGIF(sce, gmt, reducedDimNames="PCA", assayNames="normcounts")Finally, reportTGIF generates the HTML report to summarize
the result of jNMF.
reportTGIF(sce,
    html.open=FALSE,
    title="scTGIF Report for DistalLungEpithelium dataset",
    author="Koki Tsuyuzaki")## index.Rmd is created...## index.Rmd is compiled to index.html...## Loading required package: ggplot2## 
## Attaching package: 'plotly'## The following object is masked from 'package:ggplot2':
## 
##     last_plot## The following object is masked from 'package:AnnotationDbi':
## 
##     select## The following object is masked from 'package:IRanges':
## 
##     slice## The following object is masked from 'package:S4Vectors':
## 
##     rename## The following object is masked from 'package:stats':
## 
##     filter## The following object is masked from 'package:graphics':
## 
##     layout## Warning: textfont.color doesn't (yet) support data arrays
## Warning: textfont.color doesn't (yet) support data arrays
## Warning: textfont.color doesn't (yet) support data arrays
## Warning: textfont.color doesn't (yet) support data arrays
## Warning: textfont.color doesn't (yet) support data arrays
## Warning: textfont.color doesn't (yet) support data arrays## ################################################
## Data files are saved in
## /tmp/RtmpIr5lFY
## ################################################Since this function takes some time,
please type example("reportTGIF") by your own environment.
## 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] parallel  stats4    stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] plotly_4.9.3                ggplot2_3.3.3              
##  [3] msigdbr_7.4.1               GSEABase_1.54.0            
##  [5] graph_1.70.0                annotate_1.70.0            
##  [7] XML_3.99-0.6                AnnotationDbi_1.54.0       
##  [9] SingleCellExperiment_1.14.0 SummarizedExperiment_1.22.0
## [11] Biobase_2.52.0              GenomicRanges_1.44.0       
## [13] GenomeInfoDb_1.28.0         IRanges_2.26.0             
## [15] S4Vectors_0.30.0            BiocGenerics_0.38.0        
## [17] MatrixGenerics_1.4.0        matrixStats_0.58.0         
## [19] scTGIF_1.6.0                BiocStyle_2.20.0           
## 
## loaded via a namespace (and not attached):
##   [1] spam_2.6-0             plyr_1.8.6             igraph_1.2.6          
##   [4] lazyeval_0.2.2         splines_4.1.0          entropy_1.3.0         
##   [7] crosstalk_1.1.1        listenv_0.8.0          scattermore_0.7       
##  [10] digest_0.6.27          htmltools_0.5.1.1      magick_2.7.2          
##  [13] viridis_0.6.1          fansi_0.4.2            magrittr_2.0.1        
##  [16] memoise_2.0.0          tensor_1.5             cluster_2.1.2         
##  [19] ROCR_1.0-11            globals_0.14.0         Biostrings_2.60.0     
##  [22] spatstat.sparse_2.0-0  colorspace_2.0-1       blob_1.2.1            
##  [25] ggrepel_0.9.1          xfun_0.23              dplyr_1.0.6           
##  [28] hexbin_1.28.2          tcltk_4.1.0            crayon_1.4.1          
##  [31] RCurl_1.98-1.3         jsonlite_1.7.2         tagcloud_0.6          
##  [34] spatstat.data_2.1-0    survival_3.2-11        zoo_1.8-9             
##  [37] glue_1.4.2             polyclip_1.10-0        gtable_0.3.0          
##  [40] zlibbioc_1.38.0        XVector_0.32.0         leiden_0.3.7          
##  [43] DelayedArray_0.18.0    future.apply_1.7.0     maps_3.3.0            
##  [46] abind_1.4-5            scales_1.1.1           DBI_1.1.1             
##  [49] miniUI_0.1.1.1         Rcpp_1.0.6             viridisLite_0.4.0     
##  [52] xtable_1.8-4           spatstat.core_2.1-2    reticulate_1.20       
##  [55] bit_4.0.4              nnTensor_1.0.7         dotCall64_1.0-1       
##  [58] htmlwidgets_1.5.3      httr_1.4.2             RColorBrewer_1.1-2    
##  [61] ellipsis_0.3.2         Seurat_4.0.1           ica_1.0-2             
##  [64] farver_2.1.0           pkgconfig_2.0.3        uwot_0.1.10           
##  [67] deldir_0.2-10          sass_0.4.0             utf8_1.2.1            
##  [70] labeling_0.4.2         reshape2_1.4.4         tidyselect_1.1.1      
##  [73] rlang_0.4.11           later_1.2.0            munsell_0.5.0         
##  [76] tools_4.1.0            cachem_1.0.5           generics_0.1.0        
##  [79] RSQLite_2.2.7          ggridges_0.5.3         evaluate_0.14         
##  [82] stringr_1.4.0          fastmap_1.1.0          goftest_1.2-2         
##  [85] yaml_2.2.1             rTensor_1.4.8          babelgene_21.4        
##  [88] knitr_1.33             bit64_4.0.5            fitdistrplus_1.1-3    
##  [91] purrr_0.3.4            RANN_2.6.1             KEGGREST_1.32.0       
##  [94] nlme_3.1-152           pbapply_1.4-3          future_1.21.0         
##  [97] mime_0.10              concaveman_1.1.0       compiler_4.1.0        
## [100] png_0.1-7              spatstat.utils_2.1-0   tweenr_1.0.2          
## [103] tibble_3.1.2           bslib_0.2.5.1          stringi_1.6.2         
## [106] highr_0.9              fields_12.3            plot3D_1.3            
## [109] lattice_0.20-44        Matrix_1.3-3           schex_1.6.0           
## [112] vctrs_0.3.8            pillar_1.6.1           lifecycle_1.0.0       
## [115] BiocManager_1.30.15    spatstat.geom_2.1-0    lmtest_0.9-38         
## [118] jquerylib_0.1.4        RcppAnnoy_0.0.18       data.table_1.14.0     
## [121] cowplot_1.1.1          bitops_1.0-7           irlba_2.3.3           
## [124] httpuv_1.6.1           patchwork_1.1.1        R6_2.5.0              
## [127] bookdown_0.22          promises_1.2.0.1       KernSmooth_2.23-20    
## [130] gridExtra_2.3          parallelly_1.25.0      codetools_0.2-18      
## [133] MASS_7.3-54            assertthat_0.2.1       withr_2.4.2           
## [136] SeuratObject_4.0.1     sctransform_0.3.2      GenomeInfoDbData_1.2.6
## [139] mgcv_1.8-35            rpart_4.1-15           grid_4.1.0            
## [142] tidyr_1.1.3            rmarkdown_2.8          misc3d_0.9-0          
## [145] Rtsne_0.15             ggforce_0.3.3          shiny_1.6.0