Reduced dimension plotting is one of the essential tools for the analysis of single cell data. However, as the number of cells/nuclei in these these plots increases, the usefulness of these plots decreases. Many cells are plotted on top of each other obscuring information, even when taking advantage of transparency settings. This package provides binning strategies of cells/nuclei into hexagon cells. Plotting summarized information of all cells/nuclei in their respective hexagon cells presents information without obstructions. The package seemlessly works with the two most common object classes for the storage of single cell data; SingleCellExperiment from the SingleCellExperiment package and Seurat from the Seurat package.
In order to demonstrate the capabilities of the schex package, I will use the a dataset of Peripheral Blood Mononuclear Cells (PBMC) freely available from 10x Genomics. There are 2,700 single cells that were sequenced on the Illumina NextSeq 500. This data is handly availabe in the TENxPBMCData package.
tenx_pbmc3k <- TENxPBMCData(dataset = "pbmc3k")
#> see ?TENxPBMCData and browseVignettes('TENxPBMCData') for documentation
#> loading from cache
rownames(tenx_pbmc3k) <- uniquifyFeatureNames(
    rowData(tenx_pbmc3k)$ENSEMBL_ID,
    rowData(tenx_pbmc3k)$Symbol_TENx
)In the next few sections, I will perform some simple quality control steps including filtering and normalization. I will then calculate various dimension reductions and cluster the data. These steps do by no means constitute comprehensive handling of the data. For a more detailed guide the reader is referred to the following guides:
I filter cells with high mitochondrial content as well as cells with low library size or feature count.
rowData(tenx_pbmc3k)$Mito <- grepl("^MT-", rownames(tenx_pbmc3k))
colData(tenx_pbmc3k) <- cbind(
    colData(tenx_pbmc3k),
    perCellQCMetrics(tenx_pbmc3k,
        subsets = list(Mt = rowData(tenx_pbmc3k)$Mito)
    )
)
rowData(tenx_pbmc3k) <- cbind(
    rowData(tenx_pbmc3k),
    perFeatureQCMetrics(tenx_pbmc3k)
)
tenx_pbmc3k <- tenx_pbmc3k[, !colData(tenx_pbmc3k)$subsets_Mt_percent > 50]
libsize_drop <- isOutlier(tenx_pbmc3k$total,
    nmads = 3, type = "lower", log = TRUE
)
feature_drop <- isOutlier(tenx_pbmc3k$detected,
    nmads = 3, type = "lower", log = TRUE
)
tenx_pbmc3k <- tenx_pbmc3k[, !(libsize_drop | feature_drop)]I filter any genes that have 0 count for all cells.
I normalize the data by using a simple library size normalization.
I use both Principal Components Analysis (PCA) and Uniform Manifold Approximation and Projection (UMAP) in order to obtain reduced dimension representations of the data. Since there is a random component in the UMAP, I will also set a seed.
At this stage in the workflow we usually would like to plot aspects of our data in one of the reduced dimension representations. Instead of plotting this in an ordinary fashion, I will demonstrate how schex can provide a better way of plotting this.
First, I will calculate the hexagon cell representation for each cell for a specified dimension reduction representation. I decide to use nbins=40 which specifies that I divide my x range into 40 bins. Note that this might be a parameter that you want to play around with depending on the number of cells/ nuclei in your dataset. Generally, for more cells/nuclei, nbins should be increased.
First I plot how many cells are in each hexagon cell. This should be relatively even, otherwise change the nbins parameter in the previous calculation.
Next I colour the hexagon cells by some meta information, such as the majority of cells cluster membership and the median total count in each hexagon cell.
While for plotting the cluster membership the outcome is not too different from the classic plot, it is much easier to observe differences in the total count.
For convenience there is also a function that allows the calculation of label positions for factor variables. These can be overlayed with the package ggrepel.
label_df <- make_hexbin_label(tenx_pbmc3k, col = "cluster")
pp <- plot_hexbin_meta(tenx_pbmc3k, col = "cluster", action = "majority")
pp + ggrepel::geom_label_repel(
    data = label_df, aes(x = x, y = y, label = label),
    colour = "black", label.size = NA, fill = NA
)Finally, I will visualize the gene expression of the POMGNT1 gene in the hexagon cell representation.
gene_id <- "POMGNT1"
plot_hexbin_feature(tenx_pbmc3k,
    type = "logcounts", feature = gene_id,
    action = "mean", xlab = "UMAP1", ylab = "UMAP2",
    title = paste0("Mean of ", gene_id)
)Again it is much easier to observe differences in gene expression using the hexagon cell representation than the classic representation.
We can overlay the gene expression data with the clusters for convenience.
plot_hexbin_feature_plus(tenx_pbmc3k,
    col = "cluster", type = "logcounts",
    feature = "POMGNT1", action = "mean"
)schex output as ggplot objectsThe schex packages renders ordinary ggplot objects and thus these can be treated and manipulated using the ggplot grammar. For example the non-data components of the plots can be changed using the function theme.
gene_id <- "CD19"
gg <- schex::plot_hexbin_feature(tenx_pbmc3k,
    type = "logcounts", feature = gene_id,
    action = "mean", xlab = "UMAP1", ylab = "UMAP2",
    title = paste0("Mean of ", gene_id)
)
gg + theme_void()The fact that schex renders ggplot objects can also be used to save these plots. Simply use ggsave in order to save any created plot.
To find the details of the session for reproducibility, use this:
sessionInfo()
#> R version 4.5.0 Patched (2025-04-21 r88169)
#> Platform: x86_64-apple-darwin20
#> Running under: macOS Monterey 12.7.6
#> 
#> Matrix products: default
#> BLAS:   /Library/Frameworks/R.framework/Versions/4.5-x86_64/Resources/lib/libRblas.0.dylib 
#> LAPACK: /Library/Frameworks/R.framework/Versions/4.5-x86_64/Resources/lib/libRlapack.dylib;  LAPACK version 3.12.1
#> 
#> locale:
#> [1] C/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8
#> 
#> time zone: America/New_York
#> tzcode source: internal
#> 
#> attached base packages:
#> [1] stats4    stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#>  [1] ggrepel_0.9.6               scran_1.37.0               
#>  [3] scater_1.37.0               scuttle_1.19.0             
#>  [5] TENxPBMCData_1.27.0         HDF5Array_1.37.0           
#>  [7] h5mread_1.1.0               rhdf5_2.53.0               
#>  [9] DelayedArray_0.35.1         SparseArray_1.9.0          
#> [11] S4Arrays_1.9.0              abind_1.4-8                
#> [13] Matrix_1.7-3                igraph_2.1.4               
#> [15] Seurat_5.2.1                SeuratObject_5.1.0         
#> [17] sp_2.2-0                    dplyr_1.1.4                
#> [19] schex_1.23.0                SingleCellExperiment_1.31.0
#> [21] SummarizedExperiment_1.39.0 Biobase_2.69.0             
#> [23] GenomicRanges_1.61.0        GenomeInfoDb_1.45.0        
#> [25] IRanges_2.43.0              S4Vectors_0.47.0           
#> [27] BiocGenerics_0.55.0         generics_0.1.3             
#> [29] MatrixGenerics_1.21.0       matrixStats_1.5.0          
#> [31] ggplot2_3.5.2              
#> 
#> loaded via a namespace (and not attached):
#>   [1] RcppAnnoy_0.0.22        splines_4.5.0           later_1.4.2            
#>   [4] filelock_1.0.3          tibble_3.2.1            polyclip_1.10-7        
#>   [7] fastDummies_1.7.5       httr2_1.1.2             lifecycle_1.0.4        
#>  [10] edgeR_4.7.0             globals_0.17.0          lattice_0.22-7         
#>  [13] MASS_7.3-65             magrittr_2.0.3          limma_3.65.0           
#>  [16] plotly_4.10.4           sass_0.4.10             rmarkdown_2.29         
#>  [19] jquerylib_0.1.4         yaml_2.3.10             metapod_1.17.0         
#>  [22] httpuv_1.6.16           sctransform_0.4.1       spam_2.11-1            
#>  [25] spatstat.sparse_3.1-0   reticulate_1.42.0       cowplot_1.1.3          
#>  [28] pbapply_1.7-2           DBI_1.2.3               RColorBrewer_1.1-3     
#>  [31] Rtsne_0.17              purrr_1.0.4             rappdirs_0.3.3         
#>  [34] tweenr_2.0.3            GenomeInfoDbData_1.2.14 irlba_2.3.5.1          
#>  [37] listenv_0.9.1           spatstat.utils_3.1-3    goftest_1.2-3          
#>  [40] RSpectra_0.16-2         dqrng_0.4.1             spatstat.random_3.3-3  
#>  [43] fitdistrplus_1.2-2      parallelly_1.43.0       codetools_0.2-20       
#>  [46] ggforce_0.4.2           tidyselect_1.2.1        UCSC.utils_1.5.0       
#>  [49] farver_2.1.2            viridis_0.6.5           ScaledMatrix_1.17.0    
#>  [52] BiocFileCache_2.99.0    spatstat.explore_3.4-2  jsonlite_2.0.0         
#>  [55] BiocNeighbors_2.3.0     progressr_0.15.1        ggridges_0.5.6         
#>  [58] survival_3.8-3          systemfonts_1.2.2       tools_4.5.0            
#>  [61] ica_1.0-3               Rcpp_1.0.14             glue_1.8.0             
#>  [64] gridExtra_2.3           xfun_0.52               withr_3.0.2            
#>  [67] BiocManager_1.30.25     fastmap_1.2.0           bluster_1.19.0         
#>  [70] rhdf5filters_1.21.0     rsvd_1.0.5              entropy_1.3.2          
#>  [73] digest_0.6.37           R6_2.6.1                mime_0.13              
#>  [76] colorspace_2.1-1        scattermore_1.2         tensor_1.5             
#>  [79] spatstat.data_3.1-6     RSQLite_2.3.9           tidyr_1.3.1            
#>  [82] hexbin_1.28.5           data.table_1.17.0       FNN_1.1.4.1            
#>  [85] httr_1.4.7              htmlwidgets_1.6.4       uwot_0.2.3             
#>  [88] pkgconfig_2.0.3         gtable_0.3.6            blob_1.2.4             
#>  [91] lmtest_0.9-40           XVector_0.49.0          htmltools_0.5.8.1      
#>  [94] dotCall64_1.2           scales_1.3.0            png_0.1-8              
#>  [97] spatstat.univar_3.1-2   knitr_1.50              reshape2_1.4.4         
#> [100] curl_6.2.2              nlme_3.1-168            cachem_1.1.0           
#> [103] zoo_1.8-14              stringr_1.5.1           BiocVersion_3.22.0     
#> [106] KernSmooth_2.23-26      vipor_0.4.7             parallel_4.5.0         
#> [109] miniUI_0.1.2            concaveman_1.1.0        AnnotationDbi_1.71.0   
#> [112] pillar_1.10.2           grid_4.5.0              vctrs_0.6.5            
#> [115] RANN_2.6.2              promises_1.3.2          BiocSingular_1.25.0    
#> [118] beachmat_2.25.0         dbplyr_2.5.0            xtable_1.8-4           
#> [121] cluster_2.1.8.1         beeswarm_0.4.0          evaluate_1.0.3         
#> [124] locfit_1.5-9.12         cli_3.6.4               compiler_4.5.0         
#> [127] rlang_1.1.6             crayon_1.5.3            future.apply_1.11.3    
#> [130] labeling_0.4.3          ggbeeswarm_0.7.2        plyr_1.8.9             
#> [133] stringi_1.8.7           BiocParallel_1.43.0     viridisLite_0.4.2      
#> [136] deldir_2.0-4            Biostrings_2.77.0       munsell_0.5.1          
#> [139] lazyeval_0.2.2          spatstat.geom_3.3-6     V8_6.0.3               
#> [142] ExperimentHub_2.99.0    RcppHNSW_0.6.0          patchwork_1.3.0        
#> [145] bit64_4.6.0-1           future_1.40.0           Rhdf5lib_1.31.0        
#> [148] statmod_1.5.0           KEGGREST_1.49.0         shiny_1.10.0           
#> [151] AnnotationHub_3.99.0    ROCR_1.0-11             memoise_2.0.1          
#> [154] bslib_0.9.0             bit_4.6.0