Contents

Intorduction to IRIS-FGM

General introduction

IRIS-FGM integrates in-house and state-of-the-art computational tools and provides two analysis strategies, including bicluster-based co-expression gene analysis (Xie, et al., 2020) and LTMG (left-truncated mixture Gaussian model)-embedded scRNA-Seq analysis (Wan, et al., 2019).

Main function

The main idea of IRIS-FGM consists of two major strategies:

    1. biclustering
    1. quick mode (cluster)

Obejct structure

The computational frame is constructed under the S4 data structure in R. The structure of BRIC object is:

  • -BRIC_Object: name of object is called BRIC.
    • -raw_count: raw data matrix (gene in row, cell in columns, prefer using gene symbol).
    • -processed_count: normalized and imputation (default: FALSE).
    • -Meta_info: cell classification information based on LTMG and Bicluster.
    • -Discretization: discretized matrix based on qubic 1.0, which prepares for microarry and bulk RNA-Seq analysis.
    • -LTMG: LTMG slot is for storing relative results from first strategy.
      • -LTMG_discrete: Condition assigned matrix, which is generating from LTMG model.
      • -LTMG_BinarySingleSignal: binary matrix based on gene “on /off.”
      • -LTMG_BinaryMultisignal: binary matrix based on multiple condition.
      • -DimReduce: include three dimension loading score, including PCA, Tsne, and UMAP
      • -MarkerGene: Marker gene based on cell type identified by Seurat clustering method.
      • -Pathway: based on marker gene.
      • -tmp.Seurat: temporary Seurat object. In this Seurat Object, the starting matrix is LTMG signalling matrix.
    • -Bicluster:
      • -Coreg_gene: co-regulatory genes are stored in this slot as dataframe; the first column is gene name and the second column is module number.
      • -CoCond_cell: co-condition cell are stored in this slot as dataframe; the first column is cell name and the second column is module number.
      • -MarkerGene: Marker gene based on cell type identified by Markov chain clustering algorithm.
      • -Pathway: genes based on co-expression gene of gene module (from Coreg_gene).

Requirements

Environment

We recommend user to install IRIS-FGM on large memory (32GB) based linux operation system if user aims at analyzing bicluster-based co-expression analysis; if user aims at analyzing data by quick mode, we recommend to install IRIS-FGM on small memeory (8GB) based Windows or linux operation system; IRIS-FGM does not support MAC. We will assum you have the following installed:

  • R (equal or greater than 3.5)

Pre-install packge

if(!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")
# install from bioconductor
BiocManager::install(c('org.Mm.eg.db','multtest', 'org.Hs.eg.db','clusterProfiler','DEsingle', 'DrImpute', 'scater', 'scran'))
# install from cran
chooseCRANmirror()
BiocManager::install(c('devtools', 'AdaptGauss', "pheatmap", 'mixtools','MCL', 'anocva', "Polychrome", 'qgraph','Rtools','ggpubr',"ggraph", "Seurat"))

Input

  1. The input to IRIS-FGM is the single-cell RNA-seq expression matrix:
  • Rows correspond to genes and columns correspond to cells.
  • Expression units: the preferred expression values are RPKM/FPKM/CPM.
  • The data file should be tab delimited.
  1. IRIS-FGM also accepts output files from 10X CellRanger, includinhg a folder which contains three individual files and h5 file.

Others

When you perform co-expression analysis, it will output several intermediate files, thus please make sure that you have write permission to the folder where IRIS-FGM is located.

Installation

For installation, simply type the following command in your R console, please select option 3 when R asks user to update packages:

BiocManager::install("IRISFGM")

Example dataset

This tutorial run on a real dataset to illustrate the results obtained at each step.

As example, we will use Yan’s data, a dataset containing 90 cells and 20,214 genes from human embryo, to conduct cell type prediction.

Yan, L. et al. Single-cell RNA-Seq profiling of human preimplantation embryos and embryonic stem cells. Nat. Struct. Mol. Biol. 20, 1131-1139 (2013)

The original expression matrix was downloaded from https://s3.amazonaws.com/scrnaseq-public-datasets/manual-data/yan/nsmb.2660-S2.csv. The expression is provided as RPKM value. For convenience, we removed the space in the column names and deleted the second column(Transcript_ID). The processed data is available at https://bmbl.bmi.osumc.edu/downloadFiles/Yan_expression.txt.

1. Input data, create IRISCEM object, add meta information, and preprocessing.

IRIS-FGM can accepted 10X chromium input files, including a folder (contain gene name, cell name, and sparse matrix) and .h5 file.

Input data

  1. set working directory and import library
# dir.create("your working directory",recursive = TRUE)
# setwd("your working directory")
library(IRISFGM)
## 
## 
## Registered S3 method overwritten by 'gamlss':
##   method   from
##   print.ri bit
## 
  1. Read from .h5 file.
# if you will use the ".h5" as input file, please uncomment the following command.
# input_matrix <- ReadFrom10X_h5("dir_to_your_hdf5_file")
  1. Read from 10X folder, which should contain three files (barcode, gene name, and sparse matrix)
# if you will use the 10x folder as input file, please uncomment the following command.
# input_matrix <- ReadFrom10X_folder("dir_to_10x_folder")
  1. Read from .csv or .txt file

First, we should download data from the link, then we will use this data set as example to run the pipeline.

InputMatrix <- read.table(url("https://raw.githubusercontent.com/BMEngineeR/IRISFGM-data/main/Data/Yan_expression.txt"),
                          header = TRUE, 
                          row.names = 1,
                          check.names = FALSE)

Add meta information

  1. For the computational efficiency, we will use subsampling data, and create IRIS-FGM object.
set.seed(123)
seed_idx <- sample(1:nrow(InputMatrix),3000)
InputMatrix_sub <- InputMatrix[seed_idx,]
object <- CreateIRISFGMObject(InputMatrix_sub)
## Creating IRISCEM object. 
## The original input file contains 90 cells and 3000 genes 
## Removed 97 genes that total expression value is equal or less than 0
## Removed 0 cells that number of expressed gene is equal or less than 0
  1. Addmeta: this step can add customized cell label by user, the format of file passing to meta.info is data frame of which row name should be cell ID, and column name should be cell type.
my_meta <- read.table(url("https://raw.githubusercontent.com/BMEngineeR/IRISFGM-data/main/Data/Yan_cell_label.txt"),header = TRUE,row.names = 1)
object <- AddMeta(object, meta.info = my_meta)
  1. plotmeta: plot meta information based on RNA count and Feature number. This step is for the following subset step in terms of filtering out low quality data.
PlotMeta(object)

  1. remove low quality data based on the previous plot.
object <- SubsetData(object , nFeature.upper=2000,nFeature.lower=250)

Preprocesing

User can choose perform normalization or imputation based on their need. The normalization method has two options, one is the simplist CPM normalization (default normalization = 'cpm'). The other is from package scran and can be opened by using parameter normalization = 'scran', . The imputation method is from package DrImpute and can be opened by using parameter IsImputation = TRUE (default as closed).

object <- ProcessData(object, normalization = "cpm", IsImputation = FALSE)

2. Run LTMG

The argument Gene_use = 500 is top 500 highlt variant genes which are selected to run LTMG. For quick mode, we recommend to use top 2000 gene (here we use top 500 gene for saving time). On the contrary, for co-expression gene analysis, we recommend to use all gene by changing Gene_use = "all".

# do not show progress bar
quiet <- function(x) { 
  sink(tempfile()) 
  on.exit(sink()) 
  invisible(force(x)) 
} 
# demo only run top 500 gene for saving time.
object <- quiet(RunLTMG(object, Gene_use = "500"))
# you can get LTMG signal matrix
LTMG_Matrix <- GetLTMGmatrix(object)
LTMG_Matrix[1:5,1:5]
##          OoCyte_1 OoCyte_2 OoCyte_3 Zygote_2 2_Cell_embryo_1_Cell_1
## MTRNR2L2        1        2        2        2                      2
## TPT1            2        2        2        2                      3
## UBB             2        2        2        2                      2
## FABP5           2        2        2        2                      2
## PTTG1           3        3        3        3                      3

3. Biclustering

IRIS-FGM can provide biclustering function, which is based on our in-house novel algorithm, QUBIC2 (https://github.com/maqin2001/qubic2). Here we will show the basic biclustering usage of IRIS-FGM using a \(500\times 87\) expression matrix generated from previous top 500 variant genes. However, we recommend user should use “Gene_use = all”" to generate LTMG matrix.

LTMG-discretized bicluster (recommend for small single cell RNA-seq data)

User can type the following command to run discretization (LTMG) + biclustering directly:

object <- CalBinaryMultiSignal(object)
## 
  |                                                                            
  |                                                                      |   0%
  |                                                                            
  |                                                                      |   1%
  |                                                                            
  |=                                                                     |   1%
  |                                                                            
  |=                                                                     |   2%
  |                                                                            
  |==                                                                    |   2%
  |                                                                            
  |==                                                                    |   3%
  |                                                                            
  |===                                                                   |   4%
  |                                                                            
  |===                                                                   |   5%
  |                                                                            
  |====                                                                  |   5%
  |                                                                            
  |====                                                                  |   6%
  |                                                                            
  |=====                                                                 |   7%
  |                                                                            
  |=====                                                                 |   8%
  |                                                                            
  |======                                                                |   8%
  |                                                                            
  |======                                                                |   9%
  |                                                                            
  |=======                                                               |   9%
  |                                                                            
  |=======                                                               |  10%
  |                                                                            
  |=======                                                               |  11%
  |                                                                            
  |========                                                              |  11%
  |                                                                            
  |========                                                              |  12%
  |                                                                            
  |=========                                                             |  12%
  |                                                                            
  |=========                                                             |  13%
  |                                                                            
  |==========                                                            |  14%
  |                                                                            
  |==========                                                            |  15%
  |                                                                            
  |===========                                                           |  15%
  |                                                                            
  |===========                                                           |  16%
  |                                                                            
  |============                                                          |  17%
  |                                                                            
  |============                                                          |  18%
  |                                                                            
  |=============                                                         |  18%
  |                                                                            
  |=============                                                         |  19%
  |                                                                            
  |==============                                                        |  19%
  |                                                                            
  |==============                                                        |  20%
  |                                                                            
  |==============                                                        |  21%
  |                                                                            
  |===============                                                       |  21%
  |                                                                            
  |===============                                                       |  22%
  |                                                                            
  |================                                                      |  22%
  |                                                                            
  |================                                                      |  23%
  |                                                                            
  |=================                                                     |  24%
  |                                                                            
  |=================                                                     |  25%
  |                                                                            
  |==================                                                    |  25%
  |                                                                            
  |==================                                                    |  26%
  |                                                                            
  |===================                                                   |  27%
  |                                                                            
  |===================                                                   |  28%
  |                                                                            
  |====================                                                  |  28%
  |                                                                            
  |====================                                                  |  29%
  |                                                                            
  |=====================                                                 |  29%
  |                                                                            
  |=====================                                                 |  30%
  |                                                                            
  |=====================                                                 |  31%
  |                                                                            
  |======================                                                |  31%
  |                                                                            
  |======================                                                |  32%
  |                                                                            
  |=======================                                               |  32%
  |                                                                            
  |=======================                                               |  33%
  |                                                                            
  |========================                                              |  34%
  |                                                                            
  |========================                                              |  35%
  |                                                                            
  |=========================                                             |  35%
  |                                                                            
  |=========================                                             |  36%
  |                                                                            
  |==========================                                            |  37%
  |                                                                            
  |==========================                                            |  38%
  |                                                                            
  |===========================                                           |  38%
  |                                                                            
  |===========================                                           |  39%
  |                                                                            
  |============================                                          |  39%
  |                                                                            
  |============================                                          |  40%
  |                                                                            
  |============================                                          |  41%
  |                                                                            
  |=============================                                         |  41%
  |                                                                            
  |=============================                                         |  42%
  |                                                                            
  |==============================                                        |  42%
  |                                                                            
  |==============================                                        |  43%
  |                                                                            
  |===============================                                       |  44%
  |                                                                            
  |===============================                                       |  45%
  |                                                                            
  |================================                                      |  45%
  |                                                                            
  |================================                                      |  46%
  |                                                                            
  |=================================                                     |  47%
  |                                                                            
  |=================================                                     |  48%
  |                                                                            
  |==================================                                    |  48%
  |                                                                            
  |==================================                                    |  49%
  |                                                                            
  |===================================                                   |  49%
  |                                                                            
  |===================================                                   |  50%
  |                                                                            
  |===================================                                   |  51%
  |                                                                            
  |====================================                                  |  51%
  |                                                                            
  |====================================                                  |  52%
  |                                                                            
  |=====================================                                 |  52%
  |                                                                            
  |=====================================                                 |  53%
  |                                                                            
  |======================================                                |  54%
  |                                                                            
  |======================================                                |  55%
  |                                                                            
  |=======================================                               |  55%
  |                                                                            
  |=======================================                               |  56%
  |                                                                            
  |========================================                              |  57%
  |                                                                            
  |========================================                              |  58%
  |                                                                            
  |=========================================                             |  58%
  |                                                                            
  |=========================================                             |  59%
  |                                                                            
  |==========================================                            |  59%
  |                                                                            
  |==========================================                            |  60%
  |                                                                            
  |==========================================                            |  61%
  |                                                                            
  |===========================================                           |  61%
  |                                                                            
  |===========================================                           |  62%
  |                                                                            
  |============================================                          |  62%
  |                                                                            
  |============================================                          |  63%
  |                                                                            
  |=============================================                         |  64%
  |                                                                            
  |=============================================                         |  65%
  |                                                                            
  |==============================================                        |  65%
  |                                                                            
  |==============================================                        |  66%
  |                                                                            
  |===============================================                       |  67%
  |                                                                            
  |===============================================                       |  68%
  |                                                                            
  |================================================                      |  68%
  |                                                                            
  |================================================                      |  69%
  |                                                                            
  |=================================================                     |  69%
  |                                                                            
  |=================================================                     |  70%
  |                                                                            
  |=================================================                     |  71%
  |                                                                            
  |==================================================                    |  71%
  |                                                                            
  |==================================================                    |  72%
  |                                                                            
  |===================================================                   |  72%
  |                                                                            
  |===================================================                   |  73%
  |                                                                            
  |====================================================                  |  74%
  |                                                                            
  |====================================================                  |  75%
  |                                                                            
  |=====================================================                 |  75%
  |                                                                            
  |=====================================================                 |  76%
  |                                                                            
  |======================================================                |  77%
  |                                                                            
  |======================================================                |  78%
  |                                                                            
  |=======================================================               |  78%
  |                                                                            
  |=======================================================               |  79%
  |                                                                            
  |========================================================              |  79%
  |                                                                            
  |========================================================              |  80%
  |                                                                            
  |========================================================              |  81%
  |                                                                            
  |=========================================================             |  81%
  |                                                                            
  |=========================================================             |  82%
  |                                                                            
  |==========================================================            |  82%
  |                                                                            
  |==========================================================            |  83%
  |                                                                            
  |===========================================================           |  84%
  |                                                                            
  |===========================================================           |  85%
  |                                                                            
  |============================================================          |  85%
  |                                                                            
  |============================================================          |  86%
  |                                                                            
  |=============================================================         |  87%
  |                                                                            
  |=============================================================         |  88%
  |                                                                            
  |==============================================================        |  88%
  |                                                                            
  |==============================================================        |  89%
  |                                                                            
  |===============================================================       |  89%
  |                                                                            
  |===============================================================       |  90%
  |                                                                            
  |===============================================================       |  91%
  |                                                                            
  |================================================================      |  91%
  |                                                                            
  |================================================================      |  92%
  |                                                                            
  |=================================================================     |  92%
  |                                                                            
  |=================================================================     |  93%
  |                                                                            
  |==================================================================    |  94%
  |                                                                            
  |==================================================================    |  95%
  |                                                                            
  |===================================================================   |  95%
  |                                                                            
  |===================================================================   |  96%
  |                                                                            
  |====================================================================  |  97%
  |                                                                            
  |====================================================================  |  98%
  |                                                                            
  |===================================================================== |  98%
  |                                                                            
  |===================================================================== |  99%
  |                                                                            
  |======================================================================|  99%
  |                                                                            
  |======================================================================| 100%
# Please uncomment the following command and make sure to set a correct working directory so that the following command will generate intermeidate files.
# object <- RunBicluster(object, DiscretizationModel = "LTMG",OpenDual = FALSE,
#                        NumBlockOutput = 100, BlockOverlap = 0.5, BlockCellMin = 25)

(The default parameters in IRIS-FGM are BlockCellMin=15, BlockOverlap=0.7, Extension=0.90, NumBlockOutput=100 you may use other parameters as you like, just specify them in the argument)

4. Cell clustering

4.1 Perform dimension Reduction and implement Seurat clustering method.

User can use reduction = "umap" or reductopm = "tsne" to perform dimension reduction.

# demo only run top 500 gene for saving time.
object <- RunDimensionReduction(object, mat.source = "UMImatrix",reduction = "umap")
## Centering and scaling data matrix
## Warning in irlba(A = t(x = object), nv = npcs, ...): You're computing too large
## a percentage of total singular values, use a standard svd instead.
object <- RunClassification(object, k.param = 20, resolution = 0.8, algorithm = 1)
## Computing nearest neighbor graph
## Computing SNN
## Modularity Optimizer version 1.3.0 by Ludo Waltman and Nees Jan van Eck
## 
## Number of nodes: 87
## Number of edges: 1450
## 
## Running Louvain algorithm...
## Maximum modularity in 10 random starts: 0.6856
## Number of communities: 3
## Elapsed time: 0 seconds

4.2 Predict cell clusters based on Markove clustering

The cell cluster prediction of IRIS-FGM is based on the biclustering results. In short, it will construct a weighted graph based on the biclusters and then do clustering on the weighted graph. To facilitate the process, we will use the pre-generated object to perform cell clustering result based on biclustering results.

# Please uncomment the following command and make sure your working directory is the same as the directory containing intermediate output files. 
# object <- FindClassBasedOnMC(object)
data("example_object")
getMeta(example_object)[1:5,]
##          ncount_RNA nFeature Cluster Seurat_r_0.8_k_20 MC_Label
## OoCyte_1   28202.91      657       1                 2        1
## OoCyte_2   27029.84      660       1                 2        1
## OoCyte_3   26520.14      672       1                 2        1
## Zygote_1   24796.04      681       2                 2        1
## Zygote_2   23575.54      679       2                 2        1

5. Visualization and interpretation

5.1 Bicluster results

Check gene overlapping of FGMs. The results show first 19 FMGs have overlapping genes, and there is no overlapping gene between first 1 FMGs and the 15th FGM.

PlotNetwork(example_object,N.bicluster = c(1:20))

Heatmap shows relations between any two biclusters (1th and 15th bicluster).

PlotHeatmap(example_object,N.bicluster = c(1, 20),show.clusters = TRUE,show.annotation=TRUE)

Co-expression network shows gene correlation relations in one select FGM.

PlotModuleNetwork(example_object,N.bicluster = 3,method = "spearman",
                  cutoff.neg = -0.5,
                  cutoff.pos = 0.5,
                  layout = "circle",
                  node.label = TRUE,
                  node.col = "black",
                  node.label.cex = 10)

5.1 cell clustering results

Visualize cell clustering results

# cell clustering results based on Seurat clustering method 
PlotDimension(example_object,  reduction = "umap",idents = "Seurat_r_0.8_k_20")

# cell clustering results based on MCL clustering method 
PlotDimension(example_object, reduction = "umap",idents = "MC_Label")

Find global marker based on Seurat method

global_marker <- FindGlobalMarkers(example_object,idents = "Seurat_r_0.8_k_20")
## Calculating cluster 0
## Calculating cluster 1
## Calculating cluster 2
PlotMarkerHeatmap(Globalmarkers = global_marker,object = example_object,idents ="Seurat_r_0.8_k_20")

sessioninfo

sessionInfo()
## R Under development (unstable) (2023-10-22 r85388)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 22.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.19-bioc/R/lib/libRblas.so 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.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] stats     graphics  grDevices utils     datasets  methods   base     
## 
## other attached packages:
## [1] IRISFGM_1.11.0   BiocStyle_2.31.0
## 
## loaded via a namespace (and not attached):
##   [1] IRanges_2.37.0                AdaptGauss_1.5.6             
##   [3] goftest_1.2-3                 gamlss_5.4-20                
##   [5] Biostrings_2.71.1             vctrs_0.6.4                  
##   [7] spatstat.random_3.2-1         digest_0.6.33                
##   [9] png_0.1-8                     ggrepel_0.9.4                
##  [11] org.Mm.eg.db_3.18.0           deldir_1.0-9                 
##  [13] parallelly_1.36.0             magick_2.8.1                 
##  [15] MASS_7.3-60.1                 reshape2_1.4.4               
##  [17] httpuv_1.6.12                 BiocGenerics_0.49.0          
##  [19] qvalue_2.35.0                 withr_2.5.1                  
##  [21] xfun_0.40                     ggfun_0.1.3                  
##  [23] ggpubr_0.6.0                  ellipsis_0.3.2               
##  [25] survival_3.5-7                memoise_2.0.1                
##  [27] ggbeeswarm_0.7.2              clusterProfiler_4.11.0       
##  [29] gson_0.1.0                    mixtools_2.0.0               
##  [31] tidytree_0.4.5                zoo_1.8-12                   
##  [33] pbapply_1.7-2                 KEGGREST_1.43.0              
##  [35] promises_1.2.1                scatterplot3d_0.3-44         
##  [37] httr_1.4.7                    rstatix_0.7.2                
##  [39] globals_0.16.2                fitdistrplus_1.1-11          
##  [41] miniUI_0.1.1.1                generics_0.1.3               
##  [43] DOSE_3.29.0                   curl_5.1.0                   
##  [45] S4Vectors_0.41.0              zlibbioc_1.49.0              
##  [47] ScaledMatrix_1.11.0           ggraph_2.1.0                 
##  [49] polyclip_1.10-6               GenomeInfoDbData_1.2.11      
##  [51] SparseArray_1.3.0             interactiveDisplayBase_1.41.0
##  [53] xtable_1.8-4                  stringr_1.5.0                
##  [55] pracma_2.4.2                  evaluate_0.22                
##  [57] S4Arrays_1.3.0                BiocFileCache_2.11.0         
##  [59] GenomicRanges_1.55.0          bookdown_0.36                
##  [61] irlba_2.3.5.1                 colorspace_2.1-0             
##  [63] filelock_1.0.2                ROCR_1.0-11                  
##  [65] reticulate_1.34.0             spatstat.data_3.0-3          
##  [67] magrittr_2.0.3                lmtest_0.9-40                
##  [69] later_1.3.1                   viridis_0.6.4                
##  [71] ggtree_3.11.0                 lattice_0.22-5               
##  [73] spatstat.geom_3.2-7           future.apply_1.11.0          
##  [75] scattermore_1.2               scuttle_1.13.0               
##  [77] shadowtext_0.1.2              cowplot_1.1.1                
##  [79] matrixStats_1.0.0             RcppAnnoy_0.0.21             
##  [81] pillar_1.9.0                  nlme_3.1-163                 
##  [83] compiler_4.4.0                beachmat_2.19.0              
##  [85] stringi_1.7.12                tensor_1.5                   
##  [87] SummarizedExperiment_1.33.0   MPO.db_0.99.7                
##  [89] plyr_1.8.9                    crayon_1.5.2                 
##  [91] abind_1.4-5                   scater_1.31.0                
##  [93] gridGraphics_0.5-1            locfit_1.5-9.8               
##  [95] sp_2.1-1                      graphlayouts_1.0.1           
##  [97] org.Hs.eg.db_3.18.0           bit_4.0.5                    
##  [99] sandwich_3.0-2                dplyr_1.1.3                  
## [101] fastmatch_1.1-4               codetools_0.2-19             
## [103] BiocSingular_1.19.0           bslib_0.5.1                  
## [105] plotly_4.10.3                 mime_0.12                    
## [107] splines_4.4.0                 Rcpp_1.0.11                  
## [109] dbplyr_2.3.4                  sparseMatrixStats_1.15.0     
## [111] HDO.db_0.99.1                 maxLik_1.5-2                 
## [113] knitr_1.44                    blob_1.2.4                   
## [115] utf8_1.2.4                    BiocVersion_3.19.0           
## [117] fs_1.6.3                      listenv_0.9.0                
## [119] DelayedMatrixStats_1.25.0     pscl_1.5.5.1                 
## [121] expm_0.999-7                  ggsignif_0.6.4               
## [123] ggplotify_0.1.2               MCL_1.0                      
## [125] tibble_3.2.1                  Matrix_1.6-1.1               
## [127] statmod_1.5.0                 tweenr_2.0.2                 
## [129] pkgconfig_2.0.3               pheatmap_1.0.12              
## [131] tools_4.4.0                   cachem_1.0.8                 
## [133] DrImpute_1.0                  RSQLite_2.3.1                
## [135] viridisLite_0.4.2             DBI_1.1.3                    
## [137] numDeriv_2016.8-1.1           fastmap_1.1.1                
## [139] rmarkdown_2.25                scales_1.2.1                 
## [141] grid_4.4.0                    ica_1.0-3                    
## [143] Seurat_4.4.0                  broom_1.0.5                  
## [145] AnnotationHub_3.11.0          sass_0.4.7                   
## [147] patchwork_1.1.3               BiocManager_1.30.22          
## [149] Polychrome_1.5.1              carData_3.0-5                
## [151] RANN_2.6.1                    farver_2.1.1                 
## [153] tidygraph_1.2.3               scatterpie_0.2.1             
## [155] yaml_2.3.7                    VGAM_1.1-9                   
## [157] MatrixGenerics_1.15.0         cli_3.6.1                    
## [159] purrr_1.0.2                   stats4_4.4.0                 
## [161] leiden_0.4.3                  lifecycle_1.0.3              
## [163] uwot_0.1.16                   Biobase_2.63.0               
## [165] mvtnorm_1.2-3                 bluster_1.13.0               
## [167] kernlab_0.9-32                backports_1.4.1              
## [169] BiocParallel_1.37.0           gtable_0.3.4                 
## [171] ggridges_0.5.4                gamlss.dist_6.1-1            
## [173] progressr_0.14.0              parallel_4.4.0               
## [175] ape_5.7-1                     limma_3.59.0                 
## [177] jsonlite_1.8.7                edgeR_4.1.0                  
## [179] miscTools_0.6-28              bitops_1.0-7                 
## [181] ggplot2_3.4.4                 HPO.db_0.99.2                
## [183] bit64_4.0.5                   Rtsne_0.16                   
## [185] yulab.utils_0.1.0             spatstat.utils_3.0-4         
## [187] BiocNeighbors_1.21.0          SeuratObject_4.1.4           
## [189] bdsmatrix_1.3-6               metapod_1.11.0               
## [191] jquerylib_0.1.4               GOSemSim_2.29.0              
## [193] dqrng_0.3.1                   segmented_1.6-4              
## [195] lazyeval_0.2.2                shiny_1.7.5.1                
## [197] htmltools_0.5.6.1             enrichplot_1.23.0            
## [199] GO.db_3.18.0                  sctransform_0.4.1            
## [201] rappdirs_0.3.3                glue_1.6.2                   
## [203] XVector_0.43.0                RCurl_1.98-1.12              
## [205] treeio_1.27.0                 scran_1.31.0                 
## [207] gridExtra_2.3                 igraph_1.5.1                 
## [209] R6_2.5.1                      tidyr_1.3.0                  
## [211] SingleCellExperiment_1.25.0   labeling_0.4.3               
## [213] cluster_2.1.4                 bbmle_1.0.25                 
## [215] gamlss.data_6.0-2             aplot_0.2.2                  
## [217] DEsingle_1.23.0               GenomeInfoDb_1.39.0          
## [219] DelayedArray_0.29.0           tidyselect_1.2.0             
## [221] vipor_0.4.5                   ggforce_0.4.1                
## [223] car_3.1-2                     AnnotationDbi_1.65.0         
## [225] future_1.33.0                 rsvd_1.0.5                   
## [227] munsell_0.5.0                 KernSmooth_2.23-22           
## [229] data.table_1.14.8             htmlwidgets_1.6.2            
## [231] fgsea_1.29.0                  RColorBrewer_1.1-3           
## [233] rlang_1.1.1                   spatstat.sparse_3.0-3        
## [235] spatstat.explore_3.2-5        fansi_1.0.5                  
## [237] anocva_0.1.1                  beeswarm_0.4.0