Compiled date: 2021-10-26

Last edited: 2018-03-08

License: MIT + file LICENSE

1 Overview

Some tweaks can be performed to enable iSEE to run efficiently on large datasets. This includes datasets with many features (methylation, SNPs) or many columns (cytometry, single-cell RNA-seq). To demonstate some of this functionality, we will use a dataset from the TENxPBMCData dataset:

library(TENxPBMCData)
sce.pbmc <- TENxPBMCData("pbmc68k")
sce.pbmc$Library <- factor(sce.pbmc$Library)
sce.pbmc
#> class: SingleCellExperiment 
#> dim: 32738 68579 
#> metadata(0):
#> assays(1): counts
#> rownames(32738): ENSG00000243485 ENSG00000237613 ... ENSG00000215616
#>   ENSG00000215611
#> rowData names(3): ENSEMBL_ID Symbol_TENx Symbol
#> colnames: NULL
#> colData names(11): Sample Barcode ... Individual Date_published
#> reducedDimNames(0):
#> mainExpName: NULL
#> altExpNames(0):

2 Using out-of-memory matrices

Many SummarizedExperiment objects store assay matrices as in-memory matrix-like objects, be they ordinary matrices or alternative representations such as sparse matrices from the Matrix package. For example, if we looked at the Allen data, we would see that the counts are stored as an ordinary matrix.

library(scRNAseq)
sce.allen <- ReprocessedAllenData("tophat_counts")
class(assay(sce.allen, "tophat_counts"))
#> [1] "matrix" "array"

In situations involving large datasets and limited computational resources, storing the entire assay in memory may not be feasible. Rather, we can represent the data as a file-backed matrix where contents are stored on disk and retrieved on demand. Within the Bioconductor ecosystem, the easiest way of doing this is to create a HDF5Matrix, which uses a HDF5 file to store all the assay data. We see that this has already been done for use in the 68K PBMC dataset:

counts(sce.pbmc, withDimnames=FALSE)
#> <32738 x 68579> sparse matrix of class HDF5Matrix and type "integer":
#>              [,1]     [,2]     [,3]     [,4] ... [,68576] [,68577] [,68578]
#>     [1,]        0        0        0        0   .        0        0        0
#>     [2,]        0        0        0        0   .        0        0        0
#>     [3,]        0        0        0        0   .        0        0        0
#>     [4,]        0        0        0        0   .        0        0        0
#>     [5,]        0        0        0        0   .        0        0        0
#>      ...        .        .        .        .   .        .        .        .
#> [32734,]        0        0        0        0   .        0        0        0
#> [32735,]        0        0        0        0   .        0        0        0
#> [32736,]        0        0        0        0   .        0        0        0
#> [32737,]        0        0        0        0   .        0        0        0
#> [32738,]        0        0        0        0   .        0        0        0
#>          [,68579]
#>     [1,]        0
#>     [2,]        0
#>     [3,]        0
#>     [4,]        0
#>     [5,]        0
#>      ...        .
#> [32734,]        0
#> [32735,]        0
#> [32736,]        0
#> [32737,]        0
#> [32738,]        0

Despite the dimensions of this matrix, the HDF5Matrix object occupies very little space in memory.

object.size(counts(sce.pbmc, withDimnames=FALSE))
#> 2496 bytes

However, parts of the data can still be read in on demand. For all intents and purposes, the HDF5Matrix appears to be an ordinary matrix to downstream applications and can be used as such.

first.gene <- counts(sce.pbmc)[1,]
head(first.gene)
#> [1] 0 0 0 0 0 0

This means that we can use the 68K PBMC SingleCellExperiment object in iSEE() without any extra work. The app below shows the distribution of counts for everyone’s favorite gene MALAT1 across libraries. Here, iSEE() is simply retrieving data on demand from the HDF5Matrix without ever loading the entire assay matrix into memory. This enables it to run efficiently on arbitrary large datasets with limited resources.

library(iSEE)
app <- iSEE(sce.pbmc, initial=
    list(RowDataTable(Selected="ENSG00000251562", Search="MALAT1"), 
        FeatureAssayPlot(XAxis="Column data", XAxisColumnData="Library",
            YAxisFeatureSource="RowDataTable1")
    )
)

Generally speaking, these HDF5 files are written once by a process with sufficient computational resources (i.e., memory and time). We typically create HDF5Matrix objects using the writeHDF5Array() function from the HDF5Array package. After the file is created, the objects can be read many times in more deprived environments.

sce.h5 <- sce.allen
library(HDF5Array)
assay(sce.h5, "tophat_counts", withDimnames=FALSE)  <- 
    writeHDF5Array(assay(sce.h5, "tophat_counts"), file="assay.h5", name="counts")
class(assay(sce.h5, "tophat_counts", withDimnames=FALSE))
#> [1] "HDF5Matrix"
#> attr(,"package")
#> [1] "HDF5Array"
list.files("assay.h5")
#> character(0)

It is worth noting that iSEE() does not know or care that the data is stored in a HDF5 file. The app is fully compatible with any matrix-like representation of the assay data that supports dim() and [,. As such, iSEE() can be directly used with other memory-efficient objects like the DeferredMatrix and LowRankMatrix from the BiocSingular package, or perhaps the ResidualMatrix from the batchelor package.

3 Downsampling points

It is also possible to downsample points to reduce the time required to generate the plot. This involves subsetting the dataset so that only the most recently plotted point for an overlapping set of points is shown. In this manner, we avoid wasting time in plotting many points that would not be visible anyway. To demonstrate, we will re-use the 68K PBMC example and perform downsampling on the feature assay plot; we can see that its aesthetics are largely similar to the non-downsampled counterpart above.

library(iSEE)
app <- iSEE(sce.pbmc, initial=
    list(RowDataTable(Selected="ENSG00000251562", Search="MALAT1"), 
        FeatureAssayPlot(XAxis="Column data", XAxisColumnData="Library",
            YAxisFeatureSource="RowDataTable1", 
            VisualChoices="Point", Downsample=TRUE,
            VisualBoxOpen=TRUE
        )
    )
)

Downsampling is possible in all iSEE() plotting panels that represent features or samples as points. We can turn on downsampling for all such panels using the relevant field in panelDefaults(), which spares us the hassle of setting Downsample= individually in each panel constructor.

panelDefaults(Downsample=TRUE)

The downsampling only affects the visualization and the speed of the plot rendering. Any interactions with other panels occur as if all of the points were still there. For example, if one makes a brush, all of the points therein will be selected regardless of whether they were downsampled.

The downsampling resolution determines the degree to which points are considered to be overlapping. Decreasing the resolution will downsample more aggressively, improving plotting speed but potentially affecting the fidelity of the visualization. This may compromise the aesthetics of the plot when the size of the points is small, in which case an increase in resolution may be required at the cost of speed.

Obviously, downsampling will not preserve overlays for partially transparent points, but any reliance on partial transparency is probably not a good idea in the first place when there are many points.

4 Changing the interface

One can generally improve the speed of the iSEE() interface by only initializing the app with the desired panels. For example, it makes little sense to spend time rendering a RowDataPlot when only the ReducedDimensionPlot is of interest. Specification of the initial state is straightforward with the initial= argument, as described in a previous vignette.

On occasion, there may be alternative panels with more efficient visualizations for the same data. The prime example is the ReducedDimensionHexPlot class from the iSEEu package; this will create a hexplot rather than a scatter plot, thus avoiding the need to render each point in the latter.

5 Comments on deployment

It is straightforward to host iSEE applications on hosting platforms like Shiny Server or Rstudio Connect. All one needs to do is to create an app.R file that calls iSEE() with the desired parameters, and then follow the instructions for the target platform. For a better user experience, we suggest setting a minimum number of processes to avoid the initial delay from R start-up.

It is also possible to deploy and host Shiny app on shinyapps.io, a platform as a service (PaaS) provided by RStudio. In many cases, users will need to configure the settings of their deployed apps, in particular selecting larger instances to provide sufficient memory for the app. The maximum amount of 1GB available to free accounts may not be sufficient to deploy large datasets; in which case you may consider using out-of-memory matrices, filtering your dataset (e.g., removing lowly detected features), or going for a paid account. Detailed instructions to get started are available at https://shiny.rstudio.com/articles/shinyapps.html. For example, see the isee-shiny-contest app, winner of the 1st Shiny Contest.

Session Info

sessionInfo()
#> R version 4.1.1 (2021-08-10)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 20.04.3 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.14-bioc/R/lib/libRblas.so
#> LAPACK: /home/biocbuild/bbs-3.14-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] stats4    stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#>  [1] TENxPBMCData_1.11.1         HDF5Array_1.22.0           
#>  [3] rhdf5_2.38.0                DelayedArray_0.20.0        
#>  [5] Matrix_1.3-4                scater_1.22.0              
#>  [7] ggplot2_3.3.5               scuttle_1.4.0              
#>  [9] scRNAseq_2.7.2              iSEE_2.6.0                 
#> [11] SingleCellExperiment_1.16.0 SummarizedExperiment_1.24.0
#> [13] Biobase_2.54.0              GenomicRanges_1.46.0       
#> [15] GenomeInfoDb_1.30.0         IRanges_2.28.0             
#> [17] S4Vectors_0.32.0            BiocGenerics_0.40.0        
#> [19] MatrixGenerics_1.6.0        matrixStats_0.61.0         
#> [21] BiocStyle_2.22.0           
#> 
#> loaded via a namespace (and not attached):
#>   [1] circlize_0.4.13               AnnotationHub_3.2.0          
#>   [3] BiocFileCache_2.2.0           igraph_1.2.7                 
#>   [5] lazyeval_0.2.2                shinydashboard_0.7.2         
#>   [7] splines_4.1.1                 BiocParallel_1.28.0          
#>   [9] digest_0.6.28                 ensembldb_2.18.0             
#>  [11] foreach_1.5.1                 htmltools_0.5.2              
#>  [13] viridis_0.6.2                 fansi_0.5.0                  
#>  [15] magrittr_2.0.1                memoise_2.0.0                
#>  [17] ScaledMatrix_1.2.0            cluster_2.1.2                
#>  [19] doParallel_1.0.16             ComplexHeatmap_2.10.0        
#>  [21] Biostrings_2.62.0             prettyunits_1.1.1            
#>  [23] colorspace_2.0-2              blob_1.2.2                   
#>  [25] rappdirs_0.3.3                ggrepel_0.9.1                
#>  [27] xfun_0.27                     dplyr_1.0.7                  
#>  [29] crayon_1.4.1                  RCurl_1.98-1.5               
#>  [31] jsonlite_1.7.2                iterators_1.0.13             
#>  [33] glue_1.4.2                    gtable_0.3.0                 
#>  [35] zlibbioc_1.40.0               XVector_0.34.0               
#>  [37] GetoptLong_1.0.5              BiocSingular_1.10.0          
#>  [39] Rhdf5lib_1.16.0               shape_1.4.6                  
#>  [41] scales_1.1.1                  DBI_1.1.1                    
#>  [43] miniUI_0.1.1.1                Rcpp_1.0.7                   
#>  [45] viridisLite_0.4.0             xtable_1.8-4                 
#>  [47] progress_1.2.2                clue_0.3-60                  
#>  [49] rsvd_1.0.5                    bit_4.0.4                    
#>  [51] DT_0.19                       htmlwidgets_1.5.4            
#>  [53] httr_1.4.2                    RColorBrewer_1.1-2           
#>  [55] shinyAce_0.4.1                ellipsis_0.3.2               
#>  [57] pkgconfig_2.0.3               XML_3.99-0.8                 
#>  [59] sass_0.4.0                    dbplyr_2.1.1                 
#>  [61] utf8_1.2.2                    tidyselect_1.1.1             
#>  [63] rlang_0.4.12                  later_1.3.0                  
#>  [65] AnnotationDbi_1.56.0          munsell_0.5.0                
#>  [67] BiocVersion_3.14.0            tools_4.1.1                  
#>  [69] cachem_1.0.6                  generics_0.1.1               
#>  [71] RSQLite_2.2.8                 ExperimentHub_2.2.0          
#>  [73] rintrojs_0.3.0                evaluate_0.14                
#>  [75] stringr_1.4.0                 fastmap_1.1.0                
#>  [77] yaml_2.2.1                    knitr_1.36                   
#>  [79] bit64_4.0.5                   purrr_0.3.4                  
#>  [81] AnnotationFilter_1.18.0       KEGGREST_1.34.0              
#>  [83] sparseMatrixStats_1.6.0       nlme_3.1-153                 
#>  [85] mime_0.12                     xml2_1.3.2                   
#>  [87] biomaRt_2.50.0                compiler_4.1.1               
#>  [89] beeswarm_0.4.0                filelock_1.0.2               
#>  [91] curl_4.3.2                    png_0.1-7                    
#>  [93] interactiveDisplayBase_1.32.0 tibble_3.1.5                 
#>  [95] bslib_0.3.1                   stringi_1.7.5                
#>  [97] highr_0.9                     GenomicFeatures_1.46.0       
#>  [99] lattice_0.20-45               ProtGenerics_1.26.0          
#> [101] shinyjs_2.0.0                 vctrs_0.3.8                  
#> [103] rhdf5filters_1.6.0            pillar_1.6.4                 
#> [105] lifecycle_1.0.1               BiocManager_1.30.16          
#> [107] jquerylib_0.1.4               GlobalOptions_0.1.2          
#> [109] BiocNeighbors_1.12.0          irlba_2.3.3                  
#> [111] bitops_1.0-7                  rtracklayer_1.54.0           
#> [113] httpuv_1.6.3                  BiocIO_1.4.0                 
#> [115] R6_2.5.1                      bookdown_0.24                
#> [117] promises_1.2.0.1              gridExtra_2.3                
#> [119] vipor_0.4.5                   codetools_0.2-18             
#> [121] colourpicker_1.1.1            assertthat_0.2.1             
#> [123] fontawesome_0.2.2             rjson_0.2.20                 
#> [125] withr_2.4.2                   shinyWidgets_0.6.2           
#> [127] GenomicAlignments_1.30.0      Rsamtools_2.10.0             
#> [129] GenomeInfoDbData_1.2.7        mgcv_1.8-38                  
#> [131] parallel_4.1.1                hms_1.1.1                    
#> [133] beachmat_2.10.0               grid_4.1.1                   
#> [135] DelayedMatrixStats_1.16.0     rmarkdown_2.11               
#> [137] Rtsne_0.15                    shiny_1.7.1                  
#> [139] ggbeeswarm_0.6.0              restfulr_0.0.13
# devtools::session_info()