34  Spatial registration

34.1 Preamble

34.1.1 Introduction

Spatial registation is defined as the task of mapping features or spatial locations of observations from a query to a reference assay (Friston et al. 1995; Lewis et al. 2021; Nitzan et al. 2019). Here, the reference is a spatially-resolved dataset whereas the query could be an assay with or without spatial resolution.

In this chapter, we demonstrate methods that are available in R/Bioconductor for aligning (or registering) spatially-resolved datasets, where the utility and function of the alignment method is defined by the modality of the query dataset.

We will touch upon two cases: (1) alignment, where both reference and query data are spatially resolved; and, (2) reconstruction, where spatial information is inferred from non-spatial data.

34.1.2 Dependencies

In this demo, we will use the Xenium data generated from a human breast cancer biopsy (Janesick et al. 2023), which is available from OSTA.data (see Chapter 6):

Code
# retrieve dataset from OSF repo
id <- "Xenium_HumanBreast1_Janesick"
pa <- OSTA.data_load(id)
dir.create(td <- tempfile())
unzip(pa, exdir=td)
# read into 'SpatialExperiment'
xen <- readXeniumSXE(td)
xen$sample_id <- "Xenium"
xen
##  class: SpatialExperiment 
##  dim: 313 167780 
##  metadata(4): experiment.xenium transcripts cell_boundaries
##    nucleus_boundaries
##  assays(1): counts
##  rownames(313): ABCC11 ACTA2 ... ZEB2 ZNF562
##  rowData names(3): ID Symbol Type
##  colnames(167780): 1 2 ... 167779 167780
##  colData names(8): cell_id transcript_counts ... nucleus_area
##    sample_id
##  reducedDimNames(0):
##  mainExpName: NULL
##  altExpNames(4): NegControlProbe NegControlCodeword antisense BLANK
##  spatialCoords names(2) : x_centroid y_centroid
##  imgData names(1): sample_id

34.2 Alignment

Spatial omic technologies often generate data modalities that capture morphological features of tissue sections as well as omic profiles of cells, spots or other types of observations. Localization of these profiles can also be defined in different units and even in different perspectives (i.e., coordinate systems). Image alignment and registration methods provide transformations to map spatial locations of observations from one coordinate system to another, thus allowing to transfer data across observations from identical tissue sections, adjacent sections, as well as sections with similar morphology and structure.

Strategies and approaches for aligning spatial omic assays differ depending on the modalility and/or instrument used to generate these data. These methods could be categorized into two classes, where some incorporate (i) the morphology of microscopy images (image registration) of reference and query data (Friston et al. 1995) and others that rely on the (ii) spatial locations of observations (cells or spots) and the distribution of omic profiles (omics coverage) (Kiessling and Kuppe 2024).

34.2.1 Image-based

To facilitate alignment using images, we will showcase how to incorporate VoltRon to align a SpatialExperiment object of Xenium data with a post-Xenium hematoxylin and eosin (H&E) stain of the same tissue section.

The SpatialExperiment of the Xenium data does not include any images. To perform the spatial alignment via image registration, we first add an image of the corresponding DAPI staining to the object’s imgData.

ome.tiffs of full-resolution DAPI and H&E stains are available at GSM7780153.

The RBioFormats package can be used to read a specific resolution from multi-resolution ome.tiff image pyramids. Here, we choose the lowest resolution of the morphology_mip.ome.tif from the standard Xenium output. We also define the parameter (pixel-to-micron ratio) to scale the spatial coordinates of cells accordingly:

For more information on image scale factors, see here.
Code
res <- 7 # target resolution
px <- 0.2125 # px size (um)
sf <- px*(2^(res-1)) # scale factor
img <- RBioFormats::read.image(
    "morphology_mip.ome.tif", 
    resolution=res)

Before adding the selected DAPI image to the SpatialExperiment object, we first normalize the contrast to 1, and then save the image to a temporary .png file:

Code
img <- img/max(img)
png <- "Xenium_DAPI_res7.png"
EBImage::writeImage(img, files=png, type="png")

We can now add the DAPI channel to the SpatialExperiment object:

Code
xen <- addImg(xen, 
    sample_id="Xenium", 
    image_id="DAPI",
    imageSource=png, 
    scaleFactor=1/sf,
    load=TRUE)
imgData(xen)
##  DataFrame with 1 row and 4 columns
##      sample_id    image_id   data scaleFactor
##    <character> <character> <list>   <numeric>
##  1      Xenium        DAPI   ####   0.0735294

Let’s visualize the new DAPI image and overlay with cell centroids using ggspavis:

Code
# plot DAPI image
p <- plotVisium(xen, spots=FALSE, image_id="DAPI")
# overlay cells with image
img <- imgRaster(xen)
sf <- scaleFactors(xen)
xy <- spatialCoords(xen)*sf
xy[, 2] <- nrow(img)-xy[, 2]
p + geom_point(
    aes(x_centroid, y_centroid), data.frame(xy),
    shape=16, stroke=0, size=0.2, alpha=0.4, 
    col="red", inherit.aes=FALSE) 

At this stage, one may use VoltRon (or another tool) in order to register the query spatial data onto the reference (in this example, query = cell centroids, reference = H&E staining).

The return value of VoltRon’s registerSpatialData() function includes an affine transformation matrix that may be used to register spatial coordinates:

Code
# affine transformation matrix generated
# by 'VoltRon::registerSpatialData()'
mtx <- matrix(ncol=3, byrow=TRUE, c(
    5.839057e-01, -2.542718e-03, 94.00896, 
    2.372556e-03, 5.848592e-01, 105.44208, 
    -1.500111e-06, 3.715999e-06, 1.00000))

An affine map is generally composed of a linear map (scaling and rotation) and a translation, and can be apply using basic matrix multiplication and vector addition, specifically:

\[\mathbf{y}=A\mathbf{x}+\mathbf{b}\]

where \(A\) denotes the linear map, \(b\) the translation, and \(\mathbf{x}\) and \(\mathbf{y}\) correspond to original and transformed coordinates, respectively.

In R, this translates to the following operations:

Code
img <- imgRaster(xen)
xy <- spatialCoords(xen)
xy <- xy*scaleFactors(xen)
xy[, 2] <- nrow(img) - xy[, 2]
xy_reg <- t(mtx %*% rbind(t(xy), 1))
xy_reg <- xy_reg[, -3]
colnames(xy_reg) <- colnames(spatialCoords(xen))
# create a dataset copy with new coordinates
reg <- xen
imgData(reg) <- NULL
spatialCoords(reg) <- xy_reg

Now that the registered Xenium data and the post-Xenium H&E image have identical coordinate systems, we can add the H&E image directly to the registered SpatialExperiment object:

Code
tif <- "GSM7780153_Post-Xenium_HE_Rep1.ome.tif"
img <- RBioFormats::read.image(tif, resolution=7)
png <- "Xenium_H&E_res7.png"
EBImage::writeImage(tif, files=png, type="png")
Code
reg <- addImg(reg, 
    sample_id="Xenium", 
    image_id="H&E", 
    imageSource=png, 
    scaleFactor=1, 
    load=TRUE)
imgData(reg)
##  DataFrame with 1 row and 4 columns
##      sample_id    image_id   data scaleFactor
##    <character> <character> <list>   <numeric>
##  1      Xenium         H&E   ####           1

Again, we can visualize the registered Xenium cells on the H&E image:

Code
# plot H&E image
p <- plotVisium(reg, spots=FALSE, image_ids="H&E")
# overlay cells with image
img <- imgRaster(reg)
sf <- scaleFactors(reg)
xy <- spatialCoords(reg)*sf
xy[, 2] <- nrow(img)-xy[, 2]
p + geom_point(
    aes(x_centroid, y_centroid), data.frame(xy),
    shape=16, stroke=0, size=0.2, alpha=0.4, 
    col="red", inherit.aes=FALSE)

A number of R/Python frameworks can be used to automatically or manually align microscopy images associated with spatial omic datasets. The Python modules could be used through R packages such as reticulate and basilisk.

  • VoltRon (Manukyan et al. 2023) is an R package that allows alignment between multiple spatially aware datasets of distinct modalities. A Shiny application is provided to enable both automated and manual alignment across adjacent/same tissue sections where users can interactively manipulate microscopy images and choose landmarks points for co-registration.

The Shiny application interface for alignment Spatial datasets stored in VoltRon objects

  • RNiftyReg is an R wrapper package, and can be combined with mmand for automated image registration using both rigid and non-rigid approaches. Users can extract and apply the resulting transformation matrix on spatial coordinates of a SpatialExperiment object. However, the automation does not work well on images with very different orientation, scale, and intensity (e.g., Xenium and Visium; see also Chapter 36). Here is a demonstration with external data, before and after registration of the two slices:
  • STalign (Clifton et al. 2023) is a Python module that performs optimal transport across two sets of spatial coordinates with or without associated microscopy images. Rasterization of spatial coordinates could be performed when the one of either query and reference assay missing any background microscopy images with, e.g. H&E and/or DAPI staining.

  • spatialdata (Marconato et al. 2025) is a Python framework, maintained by the scverse consortium. Combined with the napari platform, spatialdata allows users to manually select landmark points before performing rigid alignment between two objects. Here we show the registration of Visium onto Xenium in napari:

34.2.2 Omics-based

Spatial alignment approaches that depend only on the spatial distribution of omic profiles are mostly available in Python frameworks which could be used in R through packages such as reticulate and basilisk.

  • PASTE is a Python-based framework (Zeira et al. 2022) that perform pairwise alignment between serial sections by solving a fused Gromov–Wasserstein optimal transport problem. The solution finds a mapping between each pair of adjacent slices by minimizing a transport cost that depends on both gene expression profiles and distance between spots of each slice.

The Shiny application interface for alignmening spatial datasets stored in `VoltRon` objects.

  • SLAT is another alternative provided as a Python module scSLAT (Xia et al. 2023) that jointly models spatial coordinates and omics features using spatial graph with node embeddings. Here, the node embeddings are generated by batch-corrected embeddings of omics features whereas the graph is constructed using edges detected by either kNN or radial neighbors. The solution is found by minimizing the cost of a bipartite matching problem.

34.3 Reconstruction

We now move to the second case where the query dataset includes no spatial information, and where we instead would like to leverage spatially-resolved reference data in order to ‘reconstruct’ the spatial coordinates of query single cells.

Below we give a list of Python frameworks that reconstruct the spatial locations of single-cell profiles. Some of these methods could be used through R using packages such as reticulate and basilisk.

  • CeLEry (Zhang et al. 2023) incorporates a supervised deep neural network model to learn the relationship between spot/cell profiles of spatial omics data and associated localization information, and then uses this model to predict the localization of single cell profiles by using the scRNAseq data as input.

  • novosparc (Nitzan et al. 2019) utilizes optimal transport (OT) to find a probabilistic embedding between expression space and physical space of single cells that minimizes the discrepancy between the pairwise graph-based distances in both of these spaces.

  • SpaOTsc (Cang and Nie 2020) also reconstructs the spatial localization of single-cell profiles by solving an OT problem. Three distance matrices are calculated which are associated with the dissimilarities between spot/cell profiles within and across two datasets, where one is a scRNAseq and the other is a spatial omics dataset. The solution to the unbalanced and structured OT problems returns an OT plan for mapping single-cell profiles to spatial locations.

34.4 Appendix

References

Cang, Zixuan, and Qing Nie. 2020. “Inferring Spatial and Signaling Relationships Between Cells from Single Cell Transcriptomic Data.” Nature Communications 11 (2084). https://doi.org/10.1038/s41467-020-15968-5.
Clifton, Kalen, Manjari Anant, Gohta Aihara, Lyla Atta, Osagie K. Aimiuwu, Justus M. Kebschull, Michael I. Miller, Daniel Tward, and Jean Fan. 2023. “STalign: Alignment of Spatial Transcriptomics Data Using Diffeomorphic Metric Mapping.” Nature Communications 14 (8123). https://doi.org/10.1038/s41467-023-43915-7.
Friston, Karl. J., J. Ashburner, C. D. Frith, J.-B. Poline, J. D. Heather, and R. S. J. Frackowiak. 1995. “Spatial Registration and Normalization of Images.” Human Brain Mapping 3: 165–89. https://doi.org/10.1002/hbm.460030303.
Janesick, Amanda, Robert Shelansky, Andrew D. Gottscho, Florian Wagner, Stephen R. Williams, Morgane Rouault, Ghezal Beliakoff, et al. 2023. “High Resolution Mapping of the Tumor Microenvironment Using Integrated Single-Cell, Spatial and in Situ Analysis.” Nature Communications 14 (8353). https://doi.org/10.1038/s41467-023-43458-x.
Kiessling, Paul, and Christoph Kuppe. 2024. “Spatial Multi-Omics: Novel Tools to Study the Complexity of Cardiovascular Diseases.” Genome Medicine 16 (14). https://doi.org/10.1186/s13073-024-01282-y.
Lewis, Sabrina M., Marie-Liesse Asselin-Labat, Quan Nguyen, Jean Berthelet, Xiao Tan, Verena C. Wimmer, Delphine Merino, Kelly L. Rogers, and Shalin H. Naik. 2021. “Spatial Omics and Multiplexed Imaging to Explore Cancer Biology.” Nature Methods 18: 997–1012. https://doi.org/10.1038/s41592-021-01203-6.
Manukyan, Artür, Ella Bahry, Emanuel Wyler, Erik Becher, Anna Pascual-Reguant, Izabela Plumbom, Hasan Onur Dikmen, et al. 2023. “VoltRon: A Spatial Omics Analysis Platform for Multi-Resolution and Multi-Omics Integration Using Image Registration.” bioRxiv. https://doi.org/10.1101/2023.12.15.571667.
Marconato, Luca, Giovanni Palla, Kevin A. Yamauchi, Isaac Virshup, Elyas Heidari, Tim Treis, Wouter-Michiel Vierdag, et al. 2025. “SpatialData: An Open and Universal Data Framework for Spatial Omics.” Nature Methods 22: 58–62. https://doi.org/10.1038/s41592-024-02212-x.
Nitzan, Mor, Nikos Karaiskos, Nir Friedman, and Nikolaus Rajewsky. 2019. “Gene Expression Cartography.” Nature 576: 132–37. https://doi.org/10.1038/s41586-019-1773-3.
Xia, Chen-Rui, Zhi-Jie Cao, Xin-Ming Tu, and Ge Gao. 2023. “Spatial-Linked Alignment Tool (SLAT) for Aligning Heterogenous Slices.” Nature Communications 14 (7236). https://doi.org/10.1038/s41467-023-43105-5.
Zeira, Ron, Max Land, Alexander Strzalkowski, and Benjamin J. Raphael. 2022. “Alignment and Integration of Spatial Transcriptomics Data.” Nature Methods 19: 567–75. https://doi.org/10.1038/s41592-022-01459-6.
Zhang, Qihuang, Shunzhou Jiang, Amelia Schroeder, Jian Hu, Kejie Li, Baohong Zhang, David Dai, Edward B. Lee, Rui Xiao, and Mingyao Li. 2023. “Leveraging Spatial Transcriptomics Data to Recover Cell Locations in Single-Cell RNA-Seq with CeLEry.” Nature Communications 14 (4050). https://doi.org/10.1038/s41467-023-39895-3.
Back to top