scTreeViz is a package for interactive visualization and exploration of Single Cell RNA sequencing data. scTreeViz provides methods for exploring hierarchical features (eg. clusters in single cell at different resolutions or taxonomic hierarchy in single cell datasets), while supporting other useful data visualization charts like heatmaps for expression and scatter plots for dimensionality reductions like UMAP or TSNE.
library(scTreeViz)
library(Seurat)
library(SC3)
library(scran)
library(scater)
library(clustree)
library(igraph)
library(scRNAseq)The first step in using the scTreeViz package is to wrap datasets into TreeViz objects. The TreeViz class extends SummarizedExperiment and provides various methods to interactively perform various operations on the underlying hierarchy and count or expression matrices. In this section, we show various ways to generate a TreeViz object either from existing Single Cell packages (SingleCellExperiment or Seurat) or from a raw count matrix and cluster hierarchy.
SingleCellExperimentA number of Single cell datasets are available as SingleCellExperiment objects through the scRNAseq package, for this usecase, we use LunSpikeInData dataset. In addition, we calculate the dimensionality reductions; UMAP, TSNE and PCA from the functions provided in scater package.
# load dataset
sce<- ZeiselBrainData()
# Normalization
sce <- logNormCounts(sce)
# calculate umap and tsne
sce <- runUMAP(sce)
sce<- runTSNE(sce)
sce<- runPCA(sce)We provide createFromSCE function to create a TreeViz object from SingleCellExperiment object. Here, the workflow works in two ways:
colData of the SingleCellExperiment object, we create clusters at different resolutions using the WalkTrap algorithm by calling an internal function generate_walktrap_hierarchy and use this cluster information for visualization.treeViz <- createFromSCE(sce, reduced_dim = c("UMAP","PCA","TSNE"))
#>  [1] "1.cluster1"   "2.cluster2"   "3.cluster3"   "4.cluster4"   "5.cluster5"  
#>  [6] "6.cluster6"   "7.cluster7"   "8.cluster8"   "9.cluster9"   "10.cluster10"
#> [11] "11.cluster11" "12.cluster12" "13.cluster13" "14.cluster14" "samples"
plot(treeViz)colData of the object, then the user should set the flag parameter check_coldata to TRUE and provide prefix for the columns where cluster information is stored.# Forming clusters
set.seed(1000)
for (i in  seq(10)) {
  clust.kmeans <- kmeans(reducedDim(sce, "TSNE"), centers = i)
  sce[[paste0("clust", i)]] <- factor(clust.kmeans$cluster)
}
treeViz<- createFromSCE(sce, check_coldata = TRUE, col_regex = "clust")
plot(treeViz)Note: In both cases the user needs to provide the name of dimensionality reductions present in the object as a parameter.
SeuratWe use the dataset pbmc_small available through Seurat to create a TreeViz object.
data(pbmc_small)
pbmc <- pbmc_smallWe then preprocess the data and find clusters at different resolutions.
pbmc[["percent.mt"]] <- PercentageFeatureSet(pbmc, pattern = "^MT-")
pbmc <- NormalizeData(pbmc)
all.genes <- rownames(pbmc)
pbmc <- ScaleData(pbmc, vars.to.regress = "percent.mt")
pbmc <- FindVariableFeatures(object = pbmc)
pbmc <- RunPCA(pbmc, features = VariableFeatures(object = pbmc))
pbmc <- FindNeighbors(pbmc, dims = 1:10)
pbmc <- FindClusters(pbmc, resolution = c(0, 0.1, 0.2, 0.3, 0.4, 0.5, 0.6, 0.7, 0.8, 0.9, 1.0), print.output = 0, save.SNN = TRUE)
pbmcThe measurements for dimensionality reduction methods we want to visualize are also added to the object via native functions in Seurat. Since PCA is already added, we calculate TSNE and UMAP
# pbmc<- RunTSNE(pbmc)
pbmc<- RunUMAP(pbmc, dims=1:3)
Reductions(pbmc)We use the createFromSeurat function to create a TreeViz object from Seurat object. In addition the object, we pass the name of dimensionality reductions present in the object as a paramter in vector format to indicate these measurements should be added to treeviz for visualization. If the mentioned reduced dimension is not present it would simply be ignored.
treeViz<- createFromSeurat(pbmc, check_metadata = TRUE, reduced_dim = c("umap","pca","tsne"))
#> [1] "6.cluster6"   "10.cluster10" "11.cluster11" "samples"     
#> [1] "umap" "pca"  "tsne"
plot(treeViz)n=64
# create a hierarchy
df<- data.frame(cluster0=rep(1,n))
for(i in seq(1,5)){
  df[[paste0("cluster",i)]]<- rep(seq(1:(2**i)),each=ceiling(n/(2**i)),len=n)
}
# generate a count matrix
counts <- matrix(rpois(6400, lambda = 10), ncol=n, nrow=100)
colnames(counts)<- seq(1:64)
# create a `TreeViz` object
treeViz <- createTreeViz(df, counts)
plot(treeViz)Start the App from the treeViz object we created. This adds a facetZoom to navigate the cluster hierarchy, a heatmap of the top n most variable genes from the dataset, where ‘n’ is selected by the user and one scatter plot for each of the reduced dimensions.
app <- startTreeviz(treeViz, top_genes = 500)Cell 416B dataset
pbmc dataset
Users can also use the interface to explore the same dataset using different visualizations available through Epiviz.
Users can also add Gene Box plots using either the frontend application, or from R session. In the following example, we visualize the 5th, 50th and 500th most variable gene as Box plots
Users need to select Add Visualization -> Gene Box PLot option from menu and then select the desired gene using the search pane in the appeared dialogue box
Selecting a gene to visualize
Users can also select the gene from R session by using the plotGene command followed by Gene name.
app$plotGene(gene="AIF1")After exploring the dataset, this command the websocket connection.
app$stop_app()sessionInfo()
#> R version 4.5.1 Patched (2025-08-23 r88802)
#> Platform: x86_64-pc-linux-gnu
#> Running under: Ubuntu 24.04.3 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.22-bioc/R/lib/libRblas.so 
#> LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0  LAPACK version 3.12.0
#> 
#> 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       
#> 
#> time zone: America/New_York
#> tzcode source: system (glibc)
#> 
#> attached base packages:
#> [1] stats4    stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#>  [1] future_1.67.0               scRNAseq_2.23.0            
#>  [3] igraph_2.1.4                clustree_0.5.1             
#>  [5] ggraph_2.2.2                scater_1.37.0              
#>  [7] ggplot2_4.0.0               scran_1.37.0               
#>  [9] scuttle_1.19.0              SingleCellExperiment_1.31.1
#> [11] SC3_1.37.0                  Seurat_5.3.0               
#> [13] SeuratObject_5.2.0          sp_2.2-0                   
#> [15] scTreeViz_1.15.0            SummarizedExperiment_1.39.2
#> [17] Biobase_2.69.1              GenomicRanges_1.61.5       
#> [19] Seqinfo_0.99.2              IRanges_2.43.5             
#> [21] S4Vectors_0.47.4            BiocGenerics_0.55.1        
#> [23] generics_0.1.4              MatrixGenerics_1.21.0      
#> [25] matrixStats_1.5.0           epivizr_2.39.0             
#> [27] BiocStyle_2.37.1           
#> 
#> loaded via a namespace (and not attached):
#>   [1] dichromat_2.0-0.1        epivizrData_1.37.2       goftest_1.2-3           
#>   [4] Biostrings_2.77.2        HDF5Array_1.37.0         vctrs_0.6.5             
#>   [7] spatstat.random_3.4-2    digest_0.6.37            png_0.1-8               
#>  [10] proxy_0.4-27             pcaPP_2.0-5              gypsum_1.5.0            
#>  [13] ggrepel_0.9.6            deldir_2.0-4             parallelly_1.45.1       
#>  [16] magick_2.9.0             alabaster.sce_1.9.0      MASS_7.3-65             
#>  [19] reshape2_1.4.4           httpuv_1.6.16            foreach_1.5.2           
#>  [22] withr_3.0.2              xfun_0.53                survival_3.8-3          
#>  [25] doRNG_1.8.6.2            memoise_2.0.1            ggbeeswarm_0.7.2        
#>  [28] zoo_1.8-14               pbapply_1.7-4            DEoptimR_1.1-4          
#>  [31] sys_3.4.3                KEGGREST_1.49.1          promises_1.3.3          
#>  [34] httr_1.4.7               restfulr_0.0.16          globals_0.18.0          
#>  [37] fitdistrplus_1.2-4       rhdf5filters_1.21.0      rhdf5_2.53.5            
#>  [40] UCSC.utils_1.5.0         miniUI_0.1.2             curl_7.0.0              
#>  [43] ScaledMatrix_1.17.0      h5mread_1.1.1            polyclip_1.10-7         
#>  [46] ExperimentHub_2.99.5     SparseArray_1.9.1        RBGL_1.85.0             
#>  [49] xtable_1.8-4             stringr_1.5.2            doParallel_1.0.17       
#>  [52] evaluate_1.0.5           S4Arrays_1.9.1           BiocFileCache_2.99.6    
#>  [55] bookdown_0.45            irlba_2.3.5.1            filelock_1.0.3          
#>  [58] ROCR_1.0-11              reticulate_1.43.0        spatstat.data_3.1-8     
#>  [61] magrittr_2.0.4           lmtest_0.9-40            later_1.4.4             
#>  [64] viridis_0.6.5            lattice_0.22-7           spatstat.geom_3.6-0     
#>  [67] future.apply_1.20.0      robustbase_0.99-6        scattermore_1.2         
#>  [70] XML_3.99-0.19            cowplot_1.2.0            RcppAnnoy_0.0.22        
#>  [73] class_7.3-23             pillar_1.11.1            nlme_3.1-168            
#>  [76] iterators_1.0.14         compiler_4.5.1           beachmat_2.25.5         
#>  [79] RSpectra_0.16-2          stringi_1.8.7            tensor_1.5.1            
#>  [82] GenomicAlignments_1.45.4 plyr_1.8.9               crayon_1.5.3            
#>  [85] abind_1.4-8              BiocIO_1.19.0            locfit_1.5-9.12         
#>  [88] graphlayouts_1.2.2       bit_4.6.0                dplyr_1.1.4             
#>  [91] codetools_0.2-20         BiocSingular_1.25.0      bslib_0.9.0             
#>  [94] e1071_1.7-16             alabaster.ranges_1.9.1   plotly_4.11.0           
#>  [97] mime_0.13                splines_4.5.1            Rcpp_1.1.0              
#> [100] fastDummies_1.7.5        dbplyr_2.5.1             knitr_1.50              
#> [103] blob_1.2.4               BiocVersion_3.22.0       AnnotationFilter_1.33.0 
#> [106] WriteXLS_6.8.0           checkmate_2.3.3          listenv_0.9.1           
#> [109] tibble_3.3.0             Matrix_1.7-4             statmod_1.5.0           
#> [112] tweenr_2.0.3             pkgconfig_2.0.3          pheatmap_1.0.13         
#> [115] tools_4.5.1              cachem_1.1.0             RSQLite_2.4.3           
#> [118] viridisLite_0.4.2        DBI_1.2.3                fastmap_1.2.0           
#> [121] rmarkdown_2.30           scales_1.4.0             grid_4.5.1              
#> [124] ica_1.0-3                epivizrServer_1.37.0     Rsamtools_2.25.3        
#> [127] AnnotationHub_3.99.6     sass_0.4.10              patchwork_1.3.2         
#> [130] FNN_1.1.4.1              BiocManager_1.30.26      dotCall64_1.2           
#> [133] graph_1.87.0             RANN_2.6.2               alabaster.schemas_1.9.0 
#> [136] farver_2.1.2             tidygraph_1.3.1          yaml_2.3.10             
#> [139] rtracklayer_1.69.1       cli_3.6.5                purrr_1.1.0             
#> [142] lifecycle_1.0.4          uwot_0.2.3               mvtnorm_1.3-3           
#> [145] backports_1.5.0          bluster_1.19.0           BiocParallel_1.43.4     
#> [148] gtable_0.3.6             rjson_0.2.23             ggridges_0.5.7          
#> [151] progressr_0.16.0         parallel_4.5.1           limma_3.65.5            
#> [154] jsonlite_2.0.0           edgeR_4.7.5              RcppHNSW_0.6.0          
#> [157] bitops_1.0-9             bit64_4.6.0-1            Rtsne_0.17              
#> [160] alabaster.matrix_1.9.0   spatstat.utils_3.2-0     BiocNeighbors_2.3.1     
#> [163] jquerylib_0.1.4          metapod_1.17.0           alabaster.se_1.9.0      
#> [166] dqrng_0.4.1              spatstat.univar_3.1-4    rrcov_1.7-7             
#> [169] lazyeval_0.2.2           alabaster.base_1.9.5     shiny_1.11.1            
#> [172] htmltools_0.5.8.1        sctransform_0.4.2        rappdirs_0.3.3          
#> [175] tinytex_0.57             ensembldb_2.33.2         glue_1.8.0              
#> [178] spam_2.11-1              httr2_1.2.1              XVector_0.49.1          
#> [181] RCurl_1.98-1.17          gridExtra_2.3            R6_2.6.1                
#> [184] tidyr_1.3.1              labeling_0.4.3           GenomicFeatures_1.61.6  
#> [187] cluster_2.1.8.1          rngtools_1.5.2           Rhdf5lib_1.31.0         
#> [190] GenomeInfoDb_1.45.12     DelayedArray_0.35.3      tidyselect_1.2.1        
#> [193] vipor_0.4.7              ProtGenerics_1.41.0      ggforce_0.5.0           
#> [196] AnnotationDbi_1.71.1     rsvd_1.0.5               KernSmooth_2.23-26      
#> [199] S7_0.2.0                 data.table_1.17.8        htmlwidgets_1.6.4       
#> [202] RColorBrewer_1.1-3       rlang_1.1.6              spatstat.sparse_3.1-0   
#> [205] spatstat.explore_3.5-3   beeswarm_0.4.0           OrganismDbi_1.51.4