Skip to contents

Installing and loading the required packages

To run the content presented in this demo, make sure to first run this following chunk in your R session. This will install the workshop package as well as all required dependencies.

install.packages("BiocManager")
BiocManager::install("iSEE/iUSEiSEE", 
                     dependencies = TRUE, 
                     build_vignettes = TRUE)

Next, we load the packages that will be used during the demo.

Alternatively, all of these would be loaded if you load the workshop package itself, i.e.:

You can also clone the GitHub repository (https://github.com/iSEE/iUSEiSEE) locally using git clone - it makes it easy to open and follow along in the vignettes.

Load example data

Most of the functionality covered in this workshop will be illustrated by means of a single-cell RNA sequencing dataset that is included in the package. You can load the dataset as follows:

sce <- readRDS(
  file = system.file("datasets", "sce_pbmc3k.RDS", package = "iUSEiSEE")
)

sce
#> class: SingleCellExperiment 
#> dim: 32738 2643 
#> metadata(0):
#> assays(2): counts logcounts
#> rownames(32738): MIR1302-10 FAM138A ... AC002321.2 AC002321.1
#> rowData names(19): ENSEMBL_ID Symbol_TENx ... FDR_cluster11
#>   FDR_cluster12
#> colnames(2643): Cell1 Cell2 ... Cell2699 Cell2700
#> colData names(24): Sample Barcode ... labels_ont cell_ontology_labels
#> reducedDimNames(3): PCA TSNE UMAP
#> mainExpName: NULL
#> altExpNames(0):

This dataset has already been processed following established principles for single-cell analysis with Bioconductor. To see how the processing was done, consult the script provided with the workflow package.

Session info

Session info
sessionInfo()
#> R version 4.5.1 (2025-06-13)
#> Platform: x86_64-pc-linux-gnu
#> Running under: Ubuntu 24.04.3 LTS
#> 
#> Matrix products: default
#> BLAS:   /usr/lib/x86_64-linux-gnu/openblas-pthread/libblas.so.3 
#> LAPACK: /usr/lib/x86_64-linux-gnu/openblas-pthread/libopenblasp-r0.3.26.so;  LAPACK version 3.12.0
#> 
#> locale:
#>  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
#>  [3] LC_TIME=en_US.UTF-8        LC_COLLATE=en_US.UTF-8    
#>  [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: Etc/UTC
#> tzcode source: system (glibc)
#> 
#> attached base packages:
#> [1] stats4    stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#>  [1] iUSEiSEE_1.0.0              iSEEindex_1.6.0            
#>  [3] iSEEhub_1.10.0              ExperimentHub_2.16.1       
#>  [5] AnnotationHub_3.16.1        BiocFileCache_2.16.2       
#>  [7] dbplyr_2.5.1                iSEEpathways_1.6.0         
#>  [9] iSEEde_1.6.0                iSEEu_1.20.0               
#> [11] iSEEhex_1.10.0              TENxPBMCData_1.26.0        
#> [13] HDF5Array_1.36.0            h5mread_1.0.1              
#> [15] rhdf5_2.52.1                DelayedArray_0.34.1        
#> [17] SparseArray_1.8.1           S4Arrays_1.8.1             
#> [19] abind_1.4-8                 Matrix_1.7-4               
#> [21] iSEE_2.20.0                 SingleCellExperiment_1.30.1
#> [23] SummarizedExperiment_1.38.1 Biobase_2.68.0             
#> [25] GenomicRanges_1.60.0        GenomeInfoDb_1.44.3        
#> [27] IRanges_2.42.0              S4Vectors_0.46.0           
#> [29] BiocGenerics_0.54.0         generics_0.1.4             
#> [31] MatrixGenerics_1.20.0       matrixStats_1.5.0          
#> [33] BiocStyle_2.36.0           
#> 
#> loaded via a namespace (and not attached):
#>   [1] splines_4.5.1           later_1.4.4             urltools_1.7.3.1       
#>   [4] filelock_1.0.3          tibble_3.3.0            triebeard_0.4.1        
#>   [7] lifecycle_1.0.4         httr2_1.2.1             edgeR_4.6.3            
#>  [10] doParallel_1.0.17       lattice_0.22-7          magrittr_2.0.4         
#>  [13] limma_3.64.3            sass_0.4.10             rmarkdown_2.30         
#>  [16] jquerylib_0.1.4         yaml_2.3.10             httpuv_1.6.16          
#>  [19] DBI_1.2.3               RColorBrewer_1.1-3      rappdirs_0.3.3         
#>  [22] circlize_0.4.16         GenomeInfoDbData_1.2.14 ggrepel_0.9.6          
#>  [25] irlba_2.3.5.1           pkgdown_2.1.3           codetools_0.2-20       
#>  [28] DT_0.34.0               scuttle_1.18.0          tidyselect_1.2.1       
#>  [31] shape_1.4.6.1           UCSC.utils_1.4.0        farver_2.1.2           
#>  [34] ScaledMatrix_1.16.0     viridis_0.6.5           shinyWidgets_0.9.0     
#>  [37] jsonlite_2.0.0          GetoptLong_1.0.5        BiocNeighbors_2.2.0    
#>  [40] scater_1.36.0           iterators_1.0.14        systemfonts_1.3.0      
#>  [43] foreach_1.5.2           tools_4.5.1             ragg_1.5.0             
#>  [46] Rcpp_1.1.0              glue_1.8.0              gridExtra_2.3          
#>  [49] xfun_0.53               mgcv_1.9-3              DESeq2_1.48.2          
#>  [52] dplyr_1.1.4             shinydashboard_0.7.3    BiocManager_1.30.26    
#>  [55] fastmap_1.2.0           rhdf5filters_1.20.0     shinyjs_2.1.0          
#>  [58] digest_0.6.37           rsvd_1.0.5              R6_2.6.1               
#>  [61] mime_0.13               textshaping_1.0.3       colorspace_2.1-2       
#>  [64] listviewer_4.0.0        RSQLite_2.4.3           paws.storage_0.9.0     
#>  [67] hexbin_1.28.5           httr_1.4.7              htmlwidgets_1.6.4      
#>  [70] pkgconfig_2.0.3         gtable_0.3.6            blob_1.2.4             
#>  [73] ComplexHeatmap_2.24.1   S7_0.2.0                XVector_0.48.0         
#>  [76] htmltools_0.5.8.1       rintrojs_0.3.4          clue_0.3-66            
#>  [79] scales_1.4.0            png_0.1-8               knitr_1.50             
#>  [82] rjson_0.2.23            nlme_3.1-168            curl_7.0.0             
#>  [85] shinyAce_0.4.4          cachem_1.1.0            GlobalOptions_0.1.2    
#>  [88] stringr_1.5.2           BiocVersion_3.21.1      parallel_4.5.1         
#>  [91] miniUI_0.1.2            vipor_0.4.7             AnnotationDbi_1.70.0   
#>  [94] desc_1.4.3              pillar_1.11.1           grid_4.5.1             
#>  [97] vctrs_0.6.5             promises_1.3.3          BiocSingular_1.24.0    
#> [100] beachmat_2.24.0         xtable_1.8-4            cluster_2.1.8.1        
#> [103] beeswarm_0.4.0          evaluate_1.0.5          cli_3.6.5              
#> [106] locfit_1.5-9.12         compiler_4.5.1          rlang_1.1.6            
#> [109] crayon_1.5.3            paws.common_0.8.5       fs_1.6.6               
#> [112] ggbeeswarm_0.7.2        stringi_1.8.7           viridisLite_0.4.2      
#> [115] BiocParallel_1.42.2     Biostrings_2.76.0       colourpicker_1.3.0     
#> [118] bit64_4.6.0-1           ggplot2_4.0.0           Rhdf5lib_1.30.0        
#> [121] KEGGREST_1.48.1         statmod_1.5.0           shiny_1.11.1           
#> [124] igraph_2.1.4            memoise_2.0.1           bslib_0.9.0            
#> [127] bit_4.6.0

References