- 1School of Mathematics and Statistics, Wuhan Textile University, Wuhan, China
- 2Center for Applied Mathematics and Interdisciplinary Sciences, Wuhan Textile University, Wuhan, China
Understanding the temporal dynamics of gene expression within spatial contexts is essential for deciphering cellular differentiation. RNA velocity, which estimates the future state of gene expression by distinguishing spliced from unspliced mRNA, offers a powerful tool for studying these dynamics. However, current spatial transcriptomics technologies face limitations in simultaneously capturing both spliced and unspliced transcripts at high resolution. To address this challenge, a novel computational framework called KSRV (Kernel PCA–based Spatial RNA Velocity) that integrates single-cell RNA-seq with spatial transcriptomics using Kernel Principal Component Analysis. It enables accurately inference of RNA velocity in spatially resolved tissue at single-cell resolution. KSRV was validated by using 10x Visium data and MERFISH datasets. The results demonstrate its both accuracy and robustness comparing with the existed method such as SIRV and spVelo. Furthermore, KSRV successfully revealed spatial differentiation trajectories in the mouse brain and during mouse organogenesis, highlighting its potential for advancing our understanding of spatially dynamic biological processes.
1 Introduction
Cell differentiation dynamics research is of great significance for understanding biological development, disease occurrence, and regenerative medicine (Saliba et al., 2014; Chen et al., 2019). However, traditional single-cell RNA sequencing (scRNA-seq) technology only provides static snapshots of gene expression in cells, failing to directly capture the dynamic changes in cell status and differentiation trajectories, and has limitations in determining cell fate directions (Bergen et al., 2020; Gao et al., 2022; Li et al., 2024). Trajectory inference algorithms aim to recon-struct cell development sequences and differentiation paths from static data by constructing potential branching trajectories based on transcriptome similarity (Haghverdi et al., 2016; Qiu et al., 2017; Street et al., 2018; Setty et al., 2019; Wolf et al., 2019; Zhou et al., 2024). In recent years, the introduction of RNA velocity theory (La Manno et al., 2018; Li et al., 2023) has brought a breakthrough to trajectory inference, enabling the inference of gene expression trends by analyzing the abundance of unspliced and spliced mRNA, thus providing a robust method for trajectory inference and offering dynamic information on the direction of cell differentiation trajectories and cell fate predictions.
Although RNA velocity analysis has been widely applied to various scRNA-seq datasets, most current methods are limited to isolated cells and neglect the spatial location of cells within tissues (Pham et al., 2023). However, spatial tissue architecture plays a crucial role in differentiation, as signaling pathways, gene expression patterns, and developmental trajectories can vary significantly across different microenvironments. Spatial transcriptomics has transformed our understanding of complex biological systems by enabling gene expression profiling with preserved spatial context. For instance, integrating RNA velocity with spatial information makes it possible to investigate the spatiotemporal dynamics of cell differentiation and improve the accuracy of cell fate prediction. (Burgess, 2019; Moses and Pachter, 2022; Wang et al., 2024).
Spatial transcriptomics techniques (Shah et al., 2016; Eng et al., 2019; Rodriques et al., 2019; Gyllborg et al., 2020; Stickels et al., 2020) provide rich tissue spatial expression profiles, but often lack spliced/unspliced transcripts, limiting their direct application to RNA velocity analysis. To address this, several approaches have attempted to align scRNA-seq data with spatial transcriptomics data to complement the spatial expression patterns (Stuart et al., 2019; Welch et al., 2019; Shengquan et al., 2021), providing possibilities for spatial RNA velocity inference. These integration methods generally fall into two categories: deconvolution and mapping (Yan et al., 2024). Deconvolution methods aim to estimate the cell-type composition or average gene expression at each spatial location but often ignore cell-level resolution (Elosua-Bayes et al., 2021; Cable et al., 2021; Kleshchevnikov et al., 2022; Li et al., 2022). Mapping-based methods, such as SpaGE (Abdelaal et al., 2020), typically perform dimensionality reduction separately on scRNA-seq and spatial transcriptomics data, and then project spatial spots into the low-dimensional embedding learned from scRNA-seq. The gene expression of each spot is then inferred by aggregating information from its nearest single-cell neighbors in the latent space. While effective for predicting missing genes, these approaches often rely on linear dimensionality reduction techniques such as PCA, which may not capture complex nonlinear relationships between modalities. Moreover, they are primarily designed for gene imputation and rarely address the inference of spatial RNA velocity.
In this study, we present KSRV, a framework for inferring spatial RNA velocity by integrating spatial transcriptomics with scRNA-seq data, enhancing data processing to better reconstruct cellular differentiation trajectories and enabling a spatially resolved depiction of cell-fate transitions. The core steps include: (1) independently perform nonlinear kernel PCA (Reverter et al., 2014) on scRNA-seq and spatial transcriptomics data to obtain their respective latent spaces, followed by alignment of these spaces; (2) infer the spliced and unspliced gene expression for each spatial spot by leveraging the gene expression profiles of neighboring single cells; (3) incorporate spatial location information to compute spatial RNA velocity vectors and reconstruct cell differentiation trajectories. KSRV enables the reconstruction of spatial differentiation trajectories at the single-cell resolution, and demonstrates the generalizability and biological interpretability across diverse datasets, offering a robust and versatile tool for studying spatial developmental dynamics.
2 Methods and materials
2.1 KSRV algorithm
According to established models of transcriptional dynamics, genes are first transcribed into unspliced mRNA, which is then spliced into mature mRNA mRNA before being degraded (Luo et al., 2022). Based on this process, RNA velocity is defined as the first-order time derivative of spliced mRNA abundance (see Equation 1) (Aivazidis et al., 2025):
here,
Step 1 - scRNA-seq and ST data are independently projected into a nonlinear latent space via kernel PCA, and then aligned.
Step 2 - Based on aligned latent representations, KSRV predicts spliced and unspliced expression at each spatial spot by borrowing information from nearby single cells.
Step 3 - With the enriched data, spatial RNA velocity vectors are estimated and used to reconstruct cell differentiation trajectories in space at single-cell resolution.
Figure 1. Overview of KSRV. (A) Transcriptional dynamics of genes. (B) Spatial transcriptomics data
2.1.1 Integration
KSRV employs Kernel PCA to project single-cell data and ST data into a shared latent space (Briscik et al., 2023). First, the algorithm identifies the common gene set between the two datasets. To account for potential domain differences and mitigate batch effects, the PRECISE domain adaptation framework (Mourragui et al., 2019) is applied, aligning the distributions of single-cell and ST data prior to dimensionality reduction. Kernel PCA with a radial basis function (RBF) kernel, whose effectiveness for non-linear data has been validated, is then applied to each dataset separately, generating high-dimensional feature spaces and their corresponding kernel matrices (Wen et al., 2021). Following (He et al., 2025), the default value of the RBF kernel gamma was adopted in our framework, as it has been shown to perform robustly in similar applications. Subsequently, eigenvectors of these matrices are computed to extract the principal components. To align the datasets, singular value decomposition (SVD) is applied to orthogonalize the components, and only those with cosine similarity exceeding a threshold of 0.3 are retained. As shown in Supplementary Figure S2, this threshold was chosen based on sensitivity analysis, where a value >0.3 consistently yielded the best performance across datasets. Finally, both datasets are projected onto the resulting common latent space, achieving alignment while preserving non-linear gene expression patterns.
2.1.2 Prediction of spatial transcriptome data
After alignment, the latent space is used to enrich the spatial transcriptomics data by inferring unmeasured spliced and unspliced gene expression. This is achieved via k-nearest neighbors (kNN) regression. Based on systematic evaluation across datasets (see Supplementary Figure S1), we set k = 50, which consistently maximized the similarity score and yielded robust predictions. For each spot
here,
where
Similarly, KSRV also uses kNN regression to transfer cell type labels from scRNA-seq to spatial data. For spatial spot
where
2.1.3 Evaluation metrics
Based on the predicted spliced and unspliced expression data, RNA velocity vectors for spatial cells are can be calculated. These vectors are then projected onto the tissue’s spatial coordinates to visualize cell dynamics in space.
To quantitatively evaluate the accuracy of the inferred differentiation trajectories, we calculate a weighted cosine similarity score between the estimated and reference RNA velocity vectors. The score is defined as:
where
2.2 Analysis of euclidean distance in cell space
We analyzed the variance of cells Euclidean distances from the origin over differentiation time in each dataset, and the positional differences measured by spatial transcriptomics are directly proportional to the Euclidean distances calculated in the two-dimensional plane. Differentiation time was divided into ten equal intervals. For each interval, we calculated the variance (
where
To capture how the variance of Euclidean distances changes over differentiation time, we fitted σ^2 at each time interval using a cubic polynomial curve:
where
Similarly, to examine the range of spot displacement over time, we divided the pseudo time into equal intervals and computed the 10th and 90th percentiles of Euclidean distances from the origin within each interval. These percentiles serve as robust proxies for the minimum and maximum distances, reducing the impact of outliers. We then fitted their temporal trends using the same cubic model described in Equation 8.
2.3 Analysis of regulatory factors of gene expression levels
To explore the contributions of temporal and spatial factors to gene expression, we introduced the concept of pseudo-spatiotemporal expression, which integrates both a cell developmental time and its spatial location.
The temporal component (
Here,
To estimate the values of
where
2.4 Description of the data set
We obtained a pair of datasets from the developing chicken heart, including 10x Visium spatial data and 10x Chromium scRNA-seq data from day 14 (Mantri et al., 2021). We ultimately obtained 1,967 spots and 12,295 genes for the Visium data, and 3,009 cells and 10,143 genes for the scRNA-seq data, along with the corresponding spliced and unspliced expressions. We obtained three spatial transcriptomics datasets (batches) measured from human osteosarcoma cells using MERFISH (Xia et al., 2019). The total Details, including total RNA counts, counts co-localized with the endoplasmic reticulum and nucleus, and spatial information, are provided in the Supplementary Material. Here, spliced and unspliced expressions are replaced by cytoplasmic and nuclear expressions, respectively. We used batch 1 (645 cells, 2,330 genes, and their spatial locations) as our spatial data, while batch 3 (323 cells, 12,903 genes) was used as simulated matched scRNA-seq data (ignoring the spatial locations of the cells).
For detailed information on Mouse Brain Development and Mouse Organogenesis (Lohoff et al., 2021; Pijuan-Sala et al., 2019), please refer to Table 1 and Supplementary Tables.
3 Results
3.1 Overview of KSRV
KSRV is a method for estimating RNA velocity at single-cell resolution in spatial transcriptomics by leveraging reference scRNA-seq data. The scRNA-seq dataset provides spliced (
3.2 Evaluation of KSRV on two datasets
To assess the accuracy and robustness of KSRV, we conducted experiments on two datasets with ground-truth or reference RNA velocity: the 10x Visium dataset of developing chicken heart tissue and the MERFISH dataset of human osteosarcoma (U-2 OS) cells.
In the chicken heart dataset, each tissue spot contains both spliced and unspliced transcript reads, allowing for direct computation of reference RNA velocity using scVelo. These reference velocities were projected onto both UMAP space and spatial coordinates (Figures 2A,B), revealing clear directional trends of cellular differentiation. Notably, velocity projections in spatial coordinates more accurately reflected the biological organization of differentiation, due to preservation of the physical structure of the tissue. As shown in Figure 2A (4), KSRV also inferred RNA velocity for this dataset by integrating single-cell transcriptomic information into spatial domains, without relying on spliced and unspliced transcript reads from spatial data. The overall differentiation trajectory inferred by KSRV closely matched the reference velocity, demonstrating its ability to accurately capture the underlying dynamic patterns.
Figure 2. Comparison of RNA velocity inference across different methods. (A) Velocity projection in UMAP space. (1-4) RNA velocity estimated directly from ST data, inferred by KSRV, SIRV, and spVelo, respectively. (B) Corresponding velocity projections in spatial coordinates, shown in the same order as in (A).
Similarly, we applied two existing methods, SIRV (Abdelaal et al., 2024), and spVelo (Long et al., 2025), to infer differentiation trajectories for this dataset (Figure 2A). While both methods produced trajectories that shared some similarity with the reference, notable discrepancies were observed in certain regions, particularly at the initial states. To quantitatively evaluate prediction accuracy, we computed cosine similarity and velocity magnitude between the predicted and reference velocities for each cell (Figure 3A). Across all cells, KSRV achieved significantly higher similarity scores (0.50) compared to both SIRV (0.47), highlighting its superior accuracy. In addition, Figures 2B, 3B illustrate the RNA velocity vectors and differentiation trajectories of cells at different spatial locations. Both KSRV and SIRV produced results that were broadly consistent with the reference trajectories. However, KSRV demonstrated superior accuracy in certain central and peripheral regions, leading to a higher similarity score (0.56) compared to SIRV (0.54). These results indicate that integrating single-cell transcriptomic data enables more precise inference of spatial RNA velocity at each spot, improving the fidelity of dynamic cellular state reconstruction.
Figure 3. (A) The top, middle, and bottom panels respectively show the high-dimensional velocity similarity, two-dimensional velocity magnitude, and weighted similarity of high-dimensional velocity for the chicken heart dataset using the KSRV and SIRV methods. (B) The top panel shows the two-dimensional velocity similarity for U-2 OS using the two methods, while the remaining panels are the same as in (A). (C) The top, middle and bottom are respectively the velocity flow of the real idle data of U-2 OS on UMAP, the velocity flow obtained by SIRV, and the velocity flow obtained by KSRV. (D) The upper and lower parts are respectively the velocity flow of the real idle data of U-2 OS in spatial coordinates and the velocity flow obtained by KSRV.
To further evaluate the performance of KSRV, we applied it to a MERFISH dataset of the human osteosarcoma cell line U-2 OS. Although it does not distinguish between spliced and unspliced transcripts, cytoplasmic and nuclear mRNA signals can serve as proxies, assuming that spliced transcripts are enriched in the cytoplasm and unspliced transcripts in the nucleus. We first divided the MERFISH dataset into eight clusters and computed RNA velocity vectors based on cytoplasmic (spliced) and nuclear (unspliced) expression levels. To simulate matched single-cell RNA-seq data, we selected cells from other MERFISH batches while ignoring their spatial positions.
In this dataset, KPCA, a key component of KSRV, demonstrated clear advantages over traditional PCA in capturing velocity flow and differentiation trajectories (Figure 3C). As shown in Figure 3C, KPCA produced velocity vectors closely resemble the reference trajectories in both global patterns and local directional details (e.g., the red boxed region), while PCA (used by SIRV) showed notable deviations in several areas. Figure 3D further confirms that KPCA recapitulates the spatial structure of differentiation dynamics more accurately than PCA, with better alignment in both clustering patterns and directional flow.
To quantitatively assess accuracy, we computed the cosine similarity and Spearman correlation between predicted and observed gene expression levels, and averaged the values across all cells. The similarity scores of the KSRV method were 0.824 (cos) and 0.787 (Spearman) respectively, which were superior to those of the SIRV method. The latter had lower scores of 0.683 and 0.612 respectively under the same evaluation. These results support the accuracy and robustness of KSRV in reconstructing cellular differentiation dynamics from imaging-based spatial transcriptomics data.
3.3 Spatiotemporal dynamics of cell differentiation revealed by KSRV
KSRV permits joint visualization of cell type, differentiation time (pseudotime) and spatial location, offering an integrated view of tissue morphogenesis (Figure 4). In developing chicken heart tissue (Figure 4A), cell-type identities (panel 1) and pseudotime (panel 2) form overlapping spatial gradients: progenitor populations occupy the ventricular apex, whereas differentiated fibroblast and valve cells localise to atrioventricular and outflow regions. Re-mapping pseudotime onto the cell-type panel (panel 3) reproduces the same spatial pattern, confirming that cardiogenesis proceeds along a well-defined anatomical axis.
Figure 4. (A) Spatiotemporal differentiation relationships in the chicken heart. (1) Distribution map of cell types at different time points during cell differentiation. (2) and (3) are respectively the front view and top view of the spatial position distribution of cells over time. (B) Spatiotemporal differentiation relationships in U-2 OS. For detailed explanations, please refer to (A). (C) Velocity flow and regional distribution during mouse brain development. (D) Velocity flow during mouse organogenesis.
Similar spatial-pseudotemporal coherence is observed in the U-2 OS MERFISH data (Figure 4B), where eight transcriptional clusters arrange along a radial trajectory from the center outward, consistent with spatially organized transcript migration during osteo-sarcoma progression. Velocity vector fields inferred from two regions of embryonic mouse tissue further highlight KSRV’s ability to resolve fine-scale dynamic patterns (Figures 4C,D). In the developing brain (Figure 4C), inferred velocity flows converge near ventricular zones and diverge toward the cortical surface, aligning with established neurogenesis patterns (Stuart et al., 2019). These velocity fields not only visualize cell migration trajectories but also offer new perspectives on the spatial orchestration of differentiation and tissue formation.
To quantify the relative contributions of temporal versus spatial regulation, we modeled cell state progression as a linear combination of pseudotime and Euclidean distance (Table 2; Supplementary Table). In the chicken heart, early-stage differentiation is primarily time-driven, with immature myocardial and vascular endothelial cells showing high pseudotime weights (0.541 and 0.536). In contrast, late-stage fibroblast and valve cell lineages exhibit lower pseudotime weights (0.233 and 0.416), indicating stronger spatial dependence. In the U-2 OS dataset, early differentiation originates from cluster 0 with a pseudotime weight of 0.325, suggesting initial spatially constrained organization. To-ward the end of differentiation, cells accumulate in cluster 4, with a higher temporal weight of 0.614, indicating a shift toward pseudotime-dominated progression (Supplementary Table S1). These results demonstrate that KSRV effectively resolves both spatial and temporal components of differentiation dynamics across diverse tissues, providing a unified framework for dissecting developmental programs.
3.4 Temporal dynamics of euclidean distance during cell differentiation
To further dissect the spatial organization of differentiation, we analyzed changes in Euclidean distance from the origin over pseudotime across four datasets: chicken heart, U-2 OS, mouse brain, and mouse organogenesis (Figure 5). In the chicken heart dataset, Euclidean distance variance decreases steadily with pseudotime (Figure 5A, top left), suggesting that cells gradually con-verge spatially during differentiation. This spatial consolidation aligns with the patterns observed in Figure 4A, where terminal fibro-blast and valve cells occupy anatomically restricted regions. Figure 5B further supports this observation: early in differentiation, cells exhibit a broad range of distances from the origin, indicating spatial dispersion; later, the spread narrows, consistent with terminal spatial convergence.
Figure 5. (A) Variance of Euclidean distance. (B) Extremum of Euclidean distance. The relationship between variance and extremum is closely related to the development of time. Take the chicken heart dataset as an example. As time goes by, the variance between distances decreases, indicating that cell differentiation tends to be concentrated, that is, the extreme values are getting closer and closer.
Conversely, in the U-2 OS dataset, distance variance increases with pseudotime (Figure 5A, top right), indicating progressive spatial dispersion. As seen in Figure 4B, terminal cell states are spatially scattered, reflecting a less constrained spatial organization during late-stage osteosarcoma progression. Figure 5B shows sustained variability in Euclidean distances throughout the trajectory, con-firming that cells remain spatially distributed across the differentiation continuum.
These results highlight contrasting spatial differentiation dynamics across tissues. While chicken heart development exhibits increasing spatial organization and compartmentalization, U-2 OS cells maintain spatial heterogeneity, possibly reflecting differences in tissue architecture or pathological state.
4 Discussions and conclusion
In this paper, a new method KSRV is proposed to infer RNA velocity in a spatial context at single-cell resolution. This method can combine single-cell data with spatial transcriptomics data. By leveraging domain adaptation and Kernel PCA, it maps integrate the information from single-cell sequencing data onto spatial transcriptomics data. Therefore, the spliced and unspliced data can be obtained in gene expression levels. And also it can obtain the cell type at the point/cell level. By anchoring these vectors to physical coordinates, KSRV reveals the spatiotemporal flow of differentiation within intact tissue. Unlike SIRV, we employ Kernel PCA to better handle non-linear data and thereby construct a more accurate velocity flow.
Benchmarking on 10x Visium chicken-heart and MERFISH U-2 OS datasets shows that KSRV reproduces reference velocity fields with substantially higher similarity score than the current SIRV method. This validates the superiority of Kernel PCA in capturing velocity flow dynamics and differentiation characteristics. Beyond validation, KSRV mapped coherent lineage streams in developing mouse brain and organogenesis sections and quantified how spatial convergence (chicken heart) or dispersion (U-2 OS) unfolds over pseudotime via Euclidean-distance analysis. These results demonstrate that KSRV not only improves velocity prediction accuracy but also delivers mechanistic insight into how temporal and spatial cues jointly shape cell-state transitions, information essential for dissecting developmental programmes and disease progression.
Despite the significant progress made by KSRV, there are some limitations that need to be specifically pointed out. Notably, when projecting high-dimensional RNA velocity vectors onto a two-dimensional coordinate system, cells may be forced to point towards neighboring cells, potentially leading to the emergence of artifacts. In the current implementation, KSRV employs a traditional fusion strategy, KPCA, to integrate spatial transcriptomics (ST) and scRNA-seq data. While KPCA is effective for aligning the two datasets based on gene expression, it does not explicitly leverage spatial relationships within ST data, potentially limiting its ability to capture spatially structured biological variation. Moreover, KSRV does not perform feature selection prior to data integration, in order to retain as many shared genes as possible and ensure sufficient information for alignment and RNA velocity inference. Nevertheless, systematic feature selection, either unimodal methods such as GeneClust (Deng et al., 2023) for scRNA-seq or SpatialDE (Svensson et al., 2018) for spatial data, or multimodal approaches such as LEGEND (Deng et al., 2024), could help reduce noise, improve computational efficiency, and highlight biologically informative genes. Although the current KPCA-based fusion strategy demonstrates satisfactory performance, future work could explore more advanced alignment methods that explicitly incorporate spatial structure, such as STANDS (Xu et al., 2024), DSTG (Song and Su, 2021), or general-purpose integration tools like Harmony (Korsunsky et al., 2019). Such improvements, combined with feature selection strategies, could further enhance KSRV’s robustness, accuracy, and biological interpretability across diverse datasets and conditions.
Data availability statement
The original contributions presented in the study are included in the article/Supplementary Material, further inquiries can be directed to the corresponding authors. All code about KSRV can be downloaded from https://github.com/YanYan116/KSRV.
Author contributions
YH: Data curation, Software, Validation, Visualization, Writing – original draft. JJ: Data curation, Methodology, Writing – review and editing. HQ: Formal Analysis, Funding acquisition, Writing – review and editing. Y-ZS: Data curation, Methodology, Project administration, Writing – review and editing. B-GZ: Conceptualization, Data curation, Funding acquisition, Investigation, Methodology, Project administration, Writing – review and editing.
Funding
The author(s) declare that financial support was received for the research and/or publication of this article. This work has been supported by the National Natural Science Foundation of China with the Nos. 12371500, 12271416, and 32571442.
Acknowledgments
AcknowledgementsThe authors would like to extend special thanks to Professor Zhou Tianshou and Cao Wenjie from Sun Yat-sen University for their insightful suggestion.
Conflict of interest
The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.
Generative AI statement
The author(s) declare that no Generative AI was used in the creation of this manuscript.
Any alternative text (alt text) provided alongside figures in this article has been generated by Frontiers with the support of artificial intelligence and reasonable efforts have been made to ensure accuracy, including review by the authors wherever possible. If you identify any issues, please contact us.
Publisher’s note
All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors and the reviewers. Any product that may be evaluated in this article, or claim that may be made by its manufacturer, is not guaranteed or endorsed by the publisher.
Supplementary material
The Supplementary Material for this article can be found online at: https://www.frontiersin.org/articles/10.3389/fgene.2025.1695803/full#supplementary-material
References
Abdelaal, T., Mourragui, S., Mahfouz, A., and Reinders, M. J. T. (2020). SpaGE: spatial gene enhancement using scRNA-seq. Nucleic Acids Res. 48, e107. doi:10.1093/nar/gkaa740
Abdelaal, T., Grossouw, L. M., Pasterkamp, R. J., Lelieveldt, B. P. F., Reinders, M. J. T., and Mahfouz, A. (2024). SIRV: spatial inference of RNA velocity at the single-cell resolution. NAR Genomics Bioinforma. 6, lqae100. doi:10.1093/nargab/lqae100
Aivazidis, A., Memi, F., Kleshchevnikov, V., Er, S., Clarke, B., Stegle, O., et al. (2025). Cell2fate infers RNA velocity modules to improve cell fate prediction. Nat. Methods 22, 698–707. doi:10.1038/s41592-025-02608-3
Bergen, V., Lange, M., Peidli, S., Wolf, F. A., and Theis, F. J. (2020). Generalizing RNA velocity to transient cell states through dynamical modeling. Nat. Biotechnol. 38, 1408–1414. doi:10.1038/s41587-020-0591-3
Briscik, M., Dillies, M.-A., and Dejean, S. (2023). Improvement of variables interpretability in kernel PCA. BMC Bioinforma. 24, 282. doi:10.1186/s12859-023-05404-y
Burgess, D. J. (2019). Spatial transcriptomics coming of age. Nat. Rev. Genet. 20, 317. doi:10.1038/s41576-019-0129-z
Cable, D. M., Murray, E., Zou, L. S., Goeva, A., Macosko, E. Z., Chen, F., et al. (2021). Robust decomposition of cell type mixtures in spatial transcriptomics. Nat. Biotechnol. 40, 517–526. doi:10.1038/s41587-021-00830-w
Chen, G., Ning, B., and Shi, T. (2019). Single-cell RNA-seq technologies and related computational data analysis. Front. Genet. 10, 317. doi:10.3389/fgene.2019.00317
Deng, T., Chen, S., Zhang, Y., Xu, Y., Feng, D., Wu, H., et al. (2023). A cofunctional grouping-based approach for non-redundant feature gene selection in unannotated single-cell RNA-seq analysis. Briefings Bioinforma. 24, bbad042. doi:10.1093/bib/bbad042
Deng, T., Huang, M., Xu, K., Lu, Y., Xu, Y., Chen, S., et al. (2024). LEGEND: identifying Co-expressed genes in multimodal transcriptomic sequencing data. Genomics Proteomics Bioinformatics. doi:10.1101/2024.10.27.620451
Elosua-Bayes, M., Nieto, P., Mereu, E., Gut, I., and Heyn, H. (2021). SPOTlight: seeded NMF regression to deconvolute spatial transcriptomics spots with single-cell transcriptomes. Nucleic Acids Res. 49, e50. doi:10.1093/nar/gkab043
Eng, C.-H. L., Lawson, M., Zhu, Q., Dries, R., Koulena, N., Takei, Y., et al. (2019). Transcriptome-scale super-resolved imaging in tissues by RNA seqFISH. Nature 568, 235–239. doi:10.1038/s41586-019-1049-y
Gao, M., Qiao, C., and Huang, Y. (2022). UniTVelo: temporally unified RNA velocity reinforces single-cell trajectory inference. Nat. Commun. 13, 6586. doi:10.1038/s41467-022-34188-7
Gyllborg, D., Langseth, C. M., Qian, X., Choi, E., Salas, S. M., Hilscher, M. M., et al. (2020). Hybridization-based in situ sequencing (HybISS) for spatially resolved transcriptomics in human and mouse brain tissue. Nucleic Acids Res. 48, e112. doi:10.1093/nar/gkaa792
Haghverdi, L., Buttner, M., Wolf, F. A., Buettner, F., and Theis, F. J. (2016). Diffusion pseudotime robustly reconstructs lineage branching. Nat. Methods 13, 845–848. doi:10.1038/nmeth.3971
He, F., Yang, R., Shi, L., and Huang, X. (2025). A decentralized framework for kernel PCA with projection consensus constraints. IEEE Trans. Pattern Analysis Mach. Intell. 47, 3908–3921. doi:10.1109/tpami.2025.3537318
Kleshchevnikov, V., Shmatko, A., Dann, E., Aivazidis, A., King, H. W., Li, T., et al. (2022). Cell2location maps fine-grained cell types in spatial transcriptomics. Nat. Biotechnol. 40, 661–671. doi:10.1038/s41587-021-01139-4
Korsunsky, I., Millard, N., Fan, J., Slowikowski, K., Zhang, F., Wei, K., et al. (2019). Fast, sensitive and accurate integration of single-cell data with harmony. Nat. Methods 16, 1289–1296. doi:10.1038/s41592-019-0619-0
La Manno, G., Soldatov, R., Zeisel, A., Braun, E., Hochgerner, H., Petukhov, V., et al. (2018). RNA velocity of single cells. Nature 560, 494–498. doi:10.1038/s41586-018-0414-6
La Manno, G., Siletti, K., Furlan, A., Gyllborg, D., Vinsland, E., Mossi Albiach, A., et al. (2021). Molecular architecture of the developing mouse brain. Nature 596, 92–96. doi:10.1038/s41586-021-03775-x
Li, B., Zhang, W., Guo, C., Xu, H., Li, L., Fang, M., et al. (2022). Benchmarking spatial and single-cell transcriptomics integration methods for transcript distribution prediction and cell type deconvolution. Nat. Methods 19, 662–670. doi:10.1038/s41592-022-01480-9
Li, S., Zhang, P., Chen, W., Ye, L., Brannan, K. W., Le, N.-T., et al. (2023). A relay velocity model infers cell-dependent RNA velocity. Nat. Biotechnol. 42, 99–108. doi:10.1038/s41587-023-01728-5
Li, J., Pan, X., Yuan, Y., and Shen, H.-B. (2024). TFvelo: gene regulation inspired RNA velocity estimation. Nat. Commun. 15, 1387. doi:10.1038/s41467-024-45661-w
Lohoff, T., Ghazanfar, S., Missarova, A., Koulena, N., Pierson, N., Griffiths, J. A., et al. (2021). Integration of spatial and single-cell transcriptomic data elucidates mouse organogenesis. Nat. Biotechnol. 40, 74–85. doi:10.1038/s41587-021-01006-2
Long, W., Liu, T., Xue, L., and Zhao, H. (2025). spVelo: RNA velocity inference for multi-batch spatial transcriptomics data. Genome Biol 26 (1), 239. doi:10.1101/2025.03.06.641905
Luo, S., Wang, Z., Zhang, Z., Zhou, T., and Zhang, J. (2022). Genome-wide inference reveals that feedback regulations constrain promoter-dependent transcriptional burst kinetics. Nucleic Acids Res. 51, 68–83. doi:10.1093/nar/gkac1204
Mantri, M., Scuderi, G. J., Abedini-Nassab, R., Wang, M. F. Z., McKellar, D., Shi, H., et al. (2021). Spatiotemporal single-cell RNA sequencing of developing chicken hearts identifies interplay between cellular differentiation and morphogenesis. Nat. Commun. 12, 1771. doi:10.1038/s41467-021-21892-z
Moses, L., and Pachter, L. (2022). Museum of spatial transcriptomics. Nat. Methods 19, 534–546. doi:10.1038/s41592-022-01409-2
Mourragui, S., Loog, M., van de Wiel, M. A., Reinders, M. J. T., and Wessels, L. F. A. (2019). PRECISE: a domain adaptation approach to transfer predictors of drug response from pre-clinical models to tumors. Bioinformatics 35, i510–i519. doi:10.1093/bioinformatics/btz372
Pham, D., Tan, X., Balderson, B., Xu, J., Grice, L. F., Yoon, S., et al. (2023). Robust mapping of spatiotemporal trajectories and cell-cell interactions in healthy and diseased tissues. Nat. Commun. 14, 7739. doi:10.1038/s41467-023-43120-6
Pijuan-Sala, B., Griffiths, J. A., Guibentif, C., Hiscock, T. W., Jawaid, W., Calero-Nieto, F. J., et al. (2019). A single-cell molecular map of mouse gastrulation and early organogenesis. Nature 566, 490–495. doi:10.1038/s41586-019-0933-9
Qiu, X., Mao, Q., Tang, Y., Wang, L., Chawla, R., Pliner, H. A., et al. (2017). Reversed graph embedding resolves complex single-cell trajectories. Nat. Methods 14, 979–982. doi:10.1038/nmeth.4402
Reverter, F., Vegas, E., and Oller, J. M. (2014). Kernel-PCA data integration with enhanced interpretability. BMC Syst. Biol. 8, S6. doi:10.1186/1752-0509-8-s2-s6
Rodriques, S. G., Stickels, R. R., Goeva, A., Martin, C. A., Murray, E., Vanderburg, C. R., et al. (2019). Slide-seq: a scalable technology for measuring genome-wide expression at high spatial resolution. Science 363, 1463–1467. doi:10.1126/science.aaw1219
Saliba, A.-E., Westermann, A. J., Gorski, S. A., and Vogel, J. (2014). Single-cell RNA-seq: advances and future challenges. Nucleic Acids Res. 42, 8845–8860. doi:10.1093/nar/gku555
Setty, M., Kiseliovas, V., Levine, J., Gayoso, A., Mazutis, L., and Pe’er, D. (2019). Characterization of cell fate probabilities in single-cell data with palantir. Nat. Biotechnol. 37, 451–460. doi:10.1038/s41587-019-0068-4
Shah, S., Lubeck, E., Zhou, W., and Cai, L. (2016). In situ transcription profiling of single cells reveals spatial organization of cells in the mouse hippocampus. Neuron 92, 342–357. doi:10.1016/j.neuron.2016.10.001
Shengquan, C., Boheng, Z., Xiaoyang, C., Xuegong, Z., and Rui, J. (2021). stPlus: a reference-based method for the accurate enhancement of spatial transcriptomics. Bioinformatics 37, i299–i307. doi:10.1093/bioinformatics/btab298
Song, Q., and Su, J. (2021). DSTG: deconvoluting spatial transcriptomics data through graph-based artificial intelligence. Briefings Bioinforma. 22, bbaa414. doi:10.1093/bib/bbaa414
Stickels, R. R., Murray, E., Kumar, P., Li, J., Marshall, J. L., Di Bella, D. J., et al. (2020). Highly sensitive spatial transcriptomics at near-cellular resolution with Slide-seqV2. Nat. Biotechnol. 39, 313–319. doi:10.1038/s41587-020-0739-1
Street, K., Risso, D., Fletcher, R. B., Das, D., Ngai, J., Yosef, N., et al. (2018). Slingshot: cell lineage and pseudotime inference for single-cell transcriptomics. BMC Genomics 19, 477. doi:10.1186/s12864-018-4772-0
Stuart, T., Butler, A., Hoffman, P., Hafemeister, C., Papalexi, E., Mauck, W. M., et al. (2019). Comprehensive integration of single-cell data. Cell 177, 1888–1902. doi:10.1016/j.cell.2019.05.031
Svensson, V., Teichmann, S. A., and Stegle, O. (2018). SpatialDE: identification of spatially variable genes. Nat. Methods 15, 343–346. doi:10.1038/nmeth.4636
Wang, M.-G., Chen, L., and Zhang, X.-F. (2024). Dual decoding of cell types and gene expression in spatial transcriptomics with PANDA. Nucleic Acids Res. 52, 12173–12190. doi:10.1093/nar/gkae876
Welch, J. D., Kozareva, V., Ferreira, A., Vanderburg, C., Martin, C., and Macosko, E. Z. (2019). Single-cell multi-omic integration compares and contrasts features of brain cell identity. Cell 177, 1873–1887. doi:10.1016/j.cell.2019.05.006
Wen, H., Yan, T., Liu, Z., and Chen, D. (2021). Integrated neural network model with pre-RBF kernels. Sci. Prog. 104, 368504211026111. doi:10.1177/00368504211026111
Wolf, F. A., Hamey, F. K., Plass, M., Solana, J., Dahlin, J. S., Gottgens, B., et al. (2019). PAGA: graph abstraction reconciles clustering with trajectory inference through a topology preserving map of single cells. Genome Biol. 20, 59. doi:10.1186/s13059-019-1663-x
Xia, C., Fan, J., Emanuel, G., Hao, J., and Zhuang, X. (2019). Spatial transcriptome profiling by MERFISH reveals subcellular RNA compartmentalization and cell cycle-dependent gene expression. Proc. Natl. Acad. Sci. 116, 19490–19499. doi:10.1073/pnas.1912459116
Xu, K., Lu, Y., Hou, S., Liu, K., Du, Y., Huang, M., et al. (2024). Detecting anomalous anatomic regions in spatial transcriptomics with STANDS. Nat. Commun. 15, 8223. doi:10.1038/s41467-024-52445-9
Yan, C., Zhu, Y., Chen, M., Yang, K., Cui, F., Zou, Q., et al. (2024). Integration tools for scRNA-seq data and spatial transcriptomics sequencing data. Briefings Funct. Genomics 23, 295–302. doi:10.1093/bfgp/elae002
Keywords: RNA velocity, scRNA-seq data, cell differentiation, Kernel PCA, data integration
Citation: He Y, Jiang J, Qiu H, Shi Y-Z and Zhang B-G (2025) KSRV: a Kernel PCA-Based framework for inferring spatial RNA velocity at single-cell resolution. Front. Genet. 16:1695803. doi: 10.3389/fgene.2025.1695803
Received: 30 August 2025; Accepted: 28 October 2025;
Published: 07 November 2025.
Edited by:
Rosalba Giugno, University of Verona, ItalyReviewed by:
Yuan Zhou, Peking University, ChinaXiaobo Sun, Zhongnan University of Economics and Law, China
Copyright © 2025 He, Jiang, Qiu, Shi and Zhang. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) and the copyright owner(s) are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.
*Correspondence: Ben-Gong Zhang, Ymd6aGFuZ0B3dHUuZWR1LmNu; Ya-Zhou Shi, eXpzaGlAd3R1LmVkdS5jbg==