Contents

1 Installation

if (!require("BiocManager")) {
  install.packages("BiocManager")
}
BiocManager::install("lisaClust")
# load required packages
library(lisaClust)
library(spicyR)
library(ggplot2)
library(SingleCellExperiment)
library(SpatialDatasets)

2 Overview

Clustering local indicators of spatial association (LISA) functions is a methodology for identifying consistent spatial organisation of multiple cell-types in an unsupervised way. This can be used to enable the characterization of interactions between multiple cell-types simultaneously and can complement traditional pairwise analysis. In our implementation our LISA curves are a localised summary of an L-function from a Poisson point process model. Our framework lisaClust can be used to provide a high-level summary of cell-type colocalization in high-parameter spatial cytometry data, facilitating the identification of distinct tissue compartments or identification of complex cellular microenvironments.

3 Quick start

3.1 Generate toy data

TO illustrate our lisaClust framework, here we consider a very simple toy example where two cell-types are completely separated spatially. We simulate data for two different images.

set.seed(51773)
x <- round(c(
  runif(200), runif(200) + 1, runif(200) + 2, runif(200) + 3,
  runif(200) + 3, runif(200) + 2, runif(200) + 1, runif(200)
), 4) * 100
y <- round(c(
  runif(200), runif(200) + 1, runif(200) + 2, runif(200) + 3,
  runif(200), runif(200) + 1, runif(200) + 2, runif(200) + 3
), 4) * 100
cellType <- factor(paste("c", rep(rep(c(1:2), rep(200, 2)), 4), sep = ""))
imageID <- rep(c("s1", "s2"), c(800, 800))

cells <- data.frame(x, y, cellType, imageID)

ggplot(cells, aes(x, y, colour = cellType)) +
  geom_point() +
  facet_wrap(~imageID) +
  theme_minimal()

3.2 Create Single Cell Experiment object

First we store our data in a SingleCellExperiment object.

SCE <- SingleCellExperiment(colData = cells)
SCE
## class: SingleCellExperiment 
## dim: 0 1600 
## metadata(0):
## assays(0):
## rownames: NULL
## rowData names(0):
## colnames: NULL
## colData names(4): x y cellType imageID
## reducedDimNames(0):
## mainExpName: NULL
## altExpNames(0):

3.3 Running lisaCLust

We can then use the convenience function lisaClust to simultaneously calculate local indicators of spatial association (LISA) functions using the lisa function and perform k-means clustering. The number of clusters can be specified with the k = parameter. In the example below, we’ve chosen k = 2, resulting in a total of 2 clusters.

These clusters are stored in colData of the SingleCellExperiment object, as a new column with the column name regions.

SCE <- lisaClust(SCE, k = 2)
colData(SCE) |> head()
## DataFrame with 6 rows and 5 columns
##           x         y cellType     imageID      region
##   <numeric> <numeric> <factor> <character> <character>
## 1     36.72     38.58       c1          s1    region_2
## 2     61.38     41.29       c1          s1    region_2
## 3     33.59     80.98       c1          s1    region_2
## 4     50.17     64.91       c1          s1    region_2
## 5     82.93     35.60       c1          s1    region_2
## 6     83.13      2.69       c1          s1    region_2

3.4 Plot identified regions

lisaClust also provides the convenient hatchingPlot function to visualise the different regions that have been demarcated by the clustering. hatchingPlot outputs a ggplot object where the regions are marked by different hatching patterns. In a real biological dataset, this allows us to plot both regions and cell-types on the same visualization.

In the example below, we can visualise our stimulated data where our 2 cell types have been separated neatly into 2 distinct regions based on which cell type each region is dominated by. region_2 is dominated by the red cell type c1, and region_1 is dominated by the blue cell type c2.

hatchingPlot(SCE, useImages = c("s1", "s2"))

## Using other clustering methods.

While the lisaClust function is convenient, we have not implemented an exhaustive suite of clustering methods as it is very easy to do this yourself. There are just two simple steps.

3.4.1 Generate LISA curves

We can calculate local indicators of spatial association (LISA) functions using the lisa function. Here the LISA curves are a localised summary of an L-function from a Poisson point process model. The radii that will be calculated over can be set with Rs.

lisaCurves <- lisa(SCE, Rs = c(20, 50, 100))

3.4.2 Perform some clustering

The LISA curves can then be used to cluster the cells. Here we use k-means clustering, other clustering methods like SOM could be used. We can store these cell clusters or cell “regions” in our SingleCellExperiment object.

# Custom clustering algorithm
kM <- kmeans(lisaCurves, 2)

# Storing clusters into colData
colData(SCE)$custom_region <- paste("region", kM$cluster, sep = "_")
colData(SCE) |> head()
## DataFrame with 6 rows and 6 columns
##           x         y cellType     imageID      region custom_region
##   <numeric> <numeric> <factor> <character> <character>   <character>
## 1     36.72     38.58       c1          s1    region_2      region_2
## 2     61.38     41.29       c1          s1    region_2      region_2
## 3     33.59     80.98       c1          s1    region_2      region_2
## 4     50.17     64.91       c1          s1    region_2      region_2
## 5     82.93     35.60       c1          s1    region_2      region_2
## 6     83.13      2.69       c1          s1    region_2      region_2

4 Keren et al. breast cancer data.

Next, we apply our lisaClust framework to two images of breast cancer from A Structured Tumor-Immune Microenvironment in Triple Negative Breast Cancer Revealed by Multiplexed Ion Beam Imaging by Keren et al. (2018)

4.1 Read in data

We will start by reading in the data from the SpatialDatasets package as a SingleCellExperiment object. Here the data is in a format consistent with that outputted by CellProfiler.

kerenSPE <- SpatialDatasets::spe_Keren_2018()

4.2 Generate LISA curves

This data includes annotation of the cell-types of each cell. Hence, we can move directly to performing k-means clustering on the local indicators of spatial association (LISA) functions using the lisaClust function, remembering to specify the imageID, cellType, and spatialCoords columns in colData. For the purpose of demonstration, we will be using only images 5 & 6 of the kerenSPE dataset.

kerenSPE <- kerenSPE[,kerenSPE$imageID %in% c("5", "6")]

kerenSPE <- lisaClust(kerenSPE,
  k = 5
)

These regions are stored in colData and can be extracted.

colData(kerenSPE)[, c("imageID", "region")] |>
  head(20)
## DataFrame with 20 rows and 2 columns
##           imageID      region
##       <character> <character>
## 21154           5    region_4
## 21155           5    region_4
## 21156           5    region_4
## 21157           5    region_3
## 21158           5    region_3
## ...           ...         ...
## 21169           5    region_3
## 21170           5    region_3
## 21171           5    region_1
## 21172           5    region_3
## 21173           5    region_1

4.3 Examine cell type enrichment

lisaClust also provides a convenient function, regionMap, for examining which cell types are located in which regions. In this example, we use this to check which cell types appear more frequently in each region than expected by chance.

Here, we clearly see that healthy epithelial and mesenchymal tissue are highly concentrated in region 1, immune cells are concentrated in regions 2 and 4, whilst tumour cells are spread out across regions 3 and 5.

We can further segregate these cells by increasing the number of clusters, ie. increasing the parameter k = in the lisaClust() function, but for the purposes of demonstration, let’s take a look at the hatchingPlot of these regions.

regionMap(kerenSPE,
  type = "bubble"
)

4.4 Plot identified regions

Finally, we can use hatchingPlot to construct a ggplot object where the regions are marked by different hatching patterns. This allows us to visualize the 5 regions and 17 cell-types simultaneously.

hatchingPlot(kerenSPE)

5 sessionInfo()

sessionInfo()
## R version 4.4.1 (2024-06-14)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 22.04.4 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.20-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] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] SpatialDatasets_1.3.0       SpatialExperiment_1.15.1   
##  [3] ExperimentHub_2.13.1        AnnotationHub_3.13.1       
##  [5] BiocFileCache_2.13.0        dbplyr_2.5.0               
##  [7] SingleCellExperiment_1.27.2 SummarizedExperiment_1.35.1
##  [9] Biobase_2.65.0              GenomicRanges_1.57.1       
## [11] GenomeInfoDb_1.41.1         IRanges_2.39.2             
## [13] S4Vectors_0.43.2            BiocGenerics_0.51.0        
## [15] MatrixGenerics_1.17.0       matrixStats_1.3.0          
## [17] ggplot2_3.5.1               spicyR_1.17.2              
## [19] lisaClust_1.13.3            BiocStyle_2.33.1           
## 
## loaded via a namespace (and not attached):
##   [1] RColorBrewer_1.1-3          jsonlite_1.8.8             
##   [3] MultiAssayExperiment_1.31.4 magrittr_2.0.3             
##   [5] spatstat.utils_3.0-5        magick_2.8.4               
##   [7] farver_2.1.2                nloptr_2.1.1               
##   [9] rmarkdown_2.27              zlibbioc_1.51.1            
##  [11] vctrs_0.6.5                 memoise_2.0.1              
##  [13] minqa_1.2.7                 spatstat.explore_3.3-1     
##  [15] tinytex_0.52                rstatix_0.7.2              
##  [17] htmltools_0.5.8.1           S4Arrays_1.5.6             
##  [19] curl_5.2.1                  broom_1.0.6                
##  [21] SparseArray_1.5.31          sass_0.4.9                 
##  [23] bslib_0.8.0                 plyr_1.8.9                 
##  [25] cachem_1.1.0                mime_0.12                  
##  [27] lifecycle_1.0.4             pkgconfig_2.0.3            
##  [29] Matrix_1.7-0                R6_2.5.1                   
##  [31] fastmap_1.2.0               GenomeInfoDbData_1.2.12    
##  [33] digest_0.6.36               numDeriv_2016.8-1.1        
##  [35] colorspace_2.1-1            AnnotationDbi_1.67.0       
##  [37] tensor_1.5                  RSQLite_2.3.7              
##  [39] ggpubr_0.6.0                labeling_0.4.3             
##  [41] filelock_1.0.3              fansi_1.0.6                
##  [43] spatstat.sparse_3.1-0       httr_1.4.7                 
##  [45] polyclip_1.10-7             abind_1.4-5                
##  [47] mgcv_1.9-1                  compiler_4.4.1             
##  [49] bit64_4.0.5                 withr_3.0.1                
##  [51] backports_1.5.0             BiocParallel_1.39.0        
##  [53] carData_3.0-5               DBI_1.2.3                  
##  [55] highr_0.11                  ggupset_0.4.0              
##  [57] ggforce_0.4.2               ggsignif_0.6.4             
##  [59] MASS_7.3-61                 concaveman_1.1.0           
##  [61] rappdirs_0.3.3              DelayedArray_0.31.11       
##  [63] rjson_0.2.21                tools_4.4.1                
##  [65] goftest_1.2-3               glue_1.7.0                 
##  [67] nlme_3.1-165                grid_4.4.1                 
##  [69] ClassifyR_3.9.3             reshape2_1.4.4             
##  [71] generics_0.1.3              gtable_0.3.5               
##  [73] spatstat.data_3.1-2         class_7.3-22               
##  [75] tidyr_1.3.1                 data.table_1.15.4          
##  [77] car_3.1-2                   utf8_1.2.4                 
##  [79] XVector_0.45.0              spatstat.geom_3.3-2        
##  [81] BiocVersion_3.20.0          pillar_1.9.0               
##  [83] stringr_1.5.1               splines_4.4.1              
##  [85] dplyr_1.1.4                 tweenr_2.0.3               
##  [87] lattice_0.22-6              survival_3.7-0             
##  [89] bit_4.0.5                   deldir_2.0-4               
##  [91] tidyselect_1.2.1            Biostrings_2.73.1          
##  [93] knitr_1.48                  V8_4.4.2                   
##  [95] bookdown_0.40               xfun_0.46                  
##  [97] pheatmap_1.0.12             fftwtools_0.9-11           
##  [99] scam_1.2-17                 stringi_1.8.4              
## [101] UCSC.utils_1.1.0            yaml_2.3.10                
## [103] boot_1.3-30                 evaluate_0.24.0            
## [105] codetools_0.2-20            tibble_3.2.1               
## [107] BiocManager_1.30.23         cli_3.6.3                  
## [109] munsell_0.5.1               jquerylib_0.1.4            
## [111] Rcpp_1.0.13                 spatstat.random_3.3-1      
## [113] png_0.1-8                   spatstat.univar_3.0-0      
## [115] parallel_4.4.1              blob_1.2.4                 
## [117] lme4_1.1-35.5               lmerTest_3.1-3             
## [119] scales_1.3.0                purrr_1.0.2                
## [121] crayon_1.5.3                rlang_1.1.4                
## [123] KEGGREST_1.45.1