BANKSY: Spatial Clustering Algorithm that Unifies Cell-Typing and Tissue Domain Segmentation (v1.3.4)
Vipul Singhal*, Nigel Chou*, Joseph Lee, Yifei Yue, Jinyue Liu, Wan Kee Chock, Li Lin, YunChing Chang, Erica Teo, Hwee Kuan Lee, Kok Hao Chen# and Shyam Prabhakar#
This repository contains the code base and examples for Building Aggregates with a Neighborhood Kernel and Spatial Yardstick developed for: BANKSY: A Spatial Clustering Algorithm that Unifes Cell Typing and Tissue Domain Segmentation. BANKSY is a method for clustering spatial transcriptomic data by augmenting the transcriptomic profile of each cell with an average of the transcriptomes of its spatial neighbors.
By incorporating neighborhood information for clustering, BANKSY is able to:
-
Improve cell-type assignment in noisy data
-
Distinguish subtly different cell-types stratified by microenvironment
-
Identify spatial zones sharing the same microenvironment
BANKSY is applicable to a wide variety of spatial technologies (e.g. 10x Visium, Slide-seq, MERFISH) and scales well to large datasets. For more details on use-cases and methods, see the preprint.
This Python version of BANKSY (compatible with Scanpy), we show how BANKSY can be used for task 1 (improving cell-type assignment) using Slide-seq and Slide-seq V2 mouse cerebellum datasets.
The R version of BANKSY is available here (https://github.com/prabhakarlab/Banksy).
Changes for v1.3.0:
- Now pip-installable! Install with
pip install pybanksy - Moved to modern src/ package layout
- Added pyproject.toml for standardized builds
- Python 3.8-3.12 support
- Optional dependencies: [notebooks], [mclust], [all]
- IPython now optional (graceful fallback to print)
Changes for v1.2.1:
- AGF has been corrected to align with R version. Normalization is with mean neighbour expression rather than mean of the modulated expression (
$e^{\phi}$ )
- Python: 3.8 - 3.12
- RAM: At least 16 GB recommended
- Dependencies: Automatically installed via pip (see
pyproject.toml)
For mclust clustering (alternative to Leiden):
pip install "pybanksy[mclust]"Requires R and rpy2.
For Jupyter notebooks:
pip install "pybanksy[notebooks]"For everything (mclust + Jupyter):
pip install "pybanksy[all]"Note: BANKSY uses Leiden clustering by default (included). Advanced users can also use any clustering method on the BANKSY matrix, including scanpy.tl.louvain().
Choose one of the following installation methods:
pip install pybanksyInstall directly from the GitHub repository:
pip install git+https://github.com/prabhakarlab/Banksy_py.gitClone the repository and install in editable mode:
git clone https://github.com/prabhakarlab/Banksy_py.git
cd Banksy_py
pip install -e .For Jupyter notebook support:
pip install -e ".[notebooks]" # From source
# or
pip install "pybanksy[notebooks]" # From PyPI (when available)For mclust clustering support (requires R):
pip install -e ".[mclust]" # From sourceFor all optional dependencies:
pip install -e ".[all]" # From source
# or
pip install "pybanksy[all]" # From PyPI (when available)To run the harmony integration example notebook:
conda install bioconda::harmony-pytorchimport scanpy as sc
from banksy.initialize_banksy import initialize_banksy
from banksy.run_banksy import run_banksy_multiparam
# Load your spatial transcriptomics data
adata = sc.read_h5ad("your_data.h5ad")
# Initialize BANKSY
coord_keys = ('x', 'y', 'spatial') # Adjust based on your data
banksy_dict = initialize_banksy(
adata,
coord_keys=coord_keys,
num_neighbours=15,
nbr_weight_decay='scaled_gaussian'
)
# Run BANKSY clustering
results_df = run_banksy_multiparam(
adata,
banksy_dict,
lambda_list=[0.2],
resolutions=[0.5, 1.0]
)Try out BANKSY using the provided example notebooks:
- slideseqv1_analysis.ipynb - Slide-seq V1 cerebellum
- slideseqv2_analysis.ipynb - Slide-seq V2 cerebellum
- starmap_analysis.ipynb - STARmap visual cortex
- CODEX_B006_ascending.ipynb - CODEX colon tissue
- DLPFC_concatenate_multisample.ipynb - Multi-sample analysis
Note: To run the slideseq_v2 dataset, download the data from the original source and save it in the data/slide_seq/v2 folder.
To run BANKSY on a spatial single-cell expression dataset in anndata
format:
- Preprocess the gene-cell matrix using
Scanpy. This includes filtering out cells and genes by various criteria, and (for sequencing-based technologies e.g. 10X Visium or Slide-seq) selecting the most highly variable genes. intitalize_banksyto generate the spatial graph (stored inbanksy_dictobject).run_banksy_multiparamto perform dimensionality reduction and clustering.
Note that individual BANKSY matrices (for given hyperparameter settings)
can be accesed from the banksy_dict object.
For example, to access the BANKSY matrix generated using
scaled_gaussian decay and lambda = 0.2, use banksy_dict['scaled gaussian'][0.2]["adata"].
(optional) For advanced users who want to understand the entire BANKSY pipeline, you also can run individual steps below:
-
Preprocess gene-cell matrix (as above). z-score by gene using
banksy.main.zscoreorscanpy.pp.scale. Functions provided in theScanpypackage handle most of these steps. Parameters and filtering criterion may vary by spatial technology and dataset source. -
Constructing the spatial graph which defines spatial neighbour relationships using
banksy.main.generate_spatial_weights_fixed_nbrs. This outputs a sparse adjacency matrix defining the graph. Visualize these withbanksy_utils.plotting.plot_graph_weights.
Some parameters that affect this step are:-
The spatial graph can be generated via the
$k_{geom}$ parameter, which connects a cell to its$k_{geom}$ nearest neighbours. This spatial graph is the basis in which the neighbourhood matrix$M$ and the azimuthal gabor filter (AGF) matrix$G$ is constructed. -
decay types: By default, we recommendscaled_gaussian, which weights a cell's neighbour expression as a gaussian envelope. Alternative methods includeuniformwhich weights all neighbours equally,reciprocalweights neighbours by$1/r$ where$r$ is the distance from neighbouring cell to the index cell.rankedranks neighbouring cells by distance with farther cells having higher rank, then sets Gaussian decay by rank. Sum of neighbour weights are always normalized to 1 for each cell. -
generate_spatial_weights_fixed_radius(not used in paper) generates a spatial graph where each cell is connected to all cells within a given radius. This leads to variable numbers of neighbours per cell.
-
-
Generate neighbour expression matrix
$N$ (ncells by ngenes) using spatial graph to average over spatial neighbours. The neighbourhood matrix can be computed by sparse matrix multiplication of the spatial graph's adjacency matrix with the gene-cell matrix. Similarly, the AGF matrix$G$ (ncells by ngenes) which represents the magnitude of expression gradient is also generated from the azimuthal transform. -
Scale original expression matrix by $√(1 - λ)$ and neighbour expression matrix by √(λ) and concatenate matrices to obtain neighbour-augmented expression matrix (ncells by 2ngenes) using
banksy.main.weighted_concatenatewithneighbourhood_contribution=$λ$ . These operations are performed on the numerical dataadata.X; usebanksy.main.bansky_matrix_to_adatato recover Anndata object with the appropriate annotations.
The following steps are identical to single cell RNA seq analysis:
-
Dimensionality reduction, particularly PCA to reduce expression matrix (either neighbour-augmented or original for comparison) to (ncells by nPCA_dims). As a default, we set
$PCA_{dims}$ = 20. -
Clustering cells by finding neighbours in expression space and cluster using graph-based clustering. Here we find expression-neighbours and perform Leiden clustering following the implemenation in Giotto.
-
Refinement (Optional) In the prescene of
noisyclusters, we offer an optional refinement step viabanksy_utils.refine_clustersto smooth labels in the clusters exclusively for domain segmentation tasks. However, we do not recommend the use of excessive refinement as it wears out fine-grained domains.
-
banksy.main.LeidenPartition
Finds neighbours in expression space and performs Leiden clustering. Aims to replicate implementation from the Giotto package as of 2020 to align with R version of the code. Note that scanpy also has a Leiden clustering implemenation with a different procedure for defining expression neighbours that can be used as an alternative. BANKSY is compatible with any clustering algorithm that takes a feature-cell matrix as input. -
labels.Label
Object for convenient computation with class labels. Converts labels to sparse one-hot vector for fast computation of connectivity across clusters with spatial graph. To obtain an array of integer labels in the usual format (e.g. [1, 1, 5, 2, ...]), useLabel.dense.
We recommend the following examples to get started with the BANKSY package
- Analyzing Slideseqv1 dataset with BANKSY
- Analyzing Slideseqv2 dataset with BANKSY
- Analyzing Starmap dataset
To reproduce the results from our manuscript, please use the branch BANKSY-manuscript.
Bug reports, questions, request for enhancements or other contributions can be raised at the issue page, or you may submit a pull request with your changes.
-
Nigel Chou (https://github.com/chousn)
-
Vipul Singhal (https://github.com/vipulsinghal02)
-
Yifei Yue (https://github.com/yifei-1021)
-
Joseph Lee (https://github.com/jleechung)
-
Wang Lurong (https://github.com/lurongw)
Refer to pyproject.toml for the supported versions of different packages.
If you want to use or cite BANKSY, please refer to the following paper:
Singhal, V., Chou, N., Lee, J. et al. BANKSY unifies cell typing and tissue domain segmentation for scalable spatial omics data analysis. Nat Genet 56, 431–441 (2024). https://doi.org/10.1038/s41588-024-01664-3
Article can be accessed at the Nature Genetics
This project is licensed under The GPLV3 license. See the LICENSE.md file for details.

