Abstract
Tumors are often polyclonal due to copy number alteration (CNA) events. Through the CNA profile, we can understand the tumor heterogeneity and consistency. CNA information is usually obtained through DNA sequencing. However, many existing studies have shown a positive correlation between the gene expression and gene copy number identified from DNA sequencing. With the development of spatial transcriptome technologies, it is urgent to develop new tools to identify genomic variation from the spatial transcriptome. Therefore, in this study, we developed CVAM, a tool to infer the CNA profile from spatial transcriptome data. Compared with existing tools, CVAM integrates the spatial information with the spot’s gene expression information together and the spatial information is indirectly introduced into the CNA inference. By applying CVAM to simulated and real spatial transcriptome data, we found that CVAM performed better in identifying CNA events. In addition, we analyzed the potential co-occurrence and mutual exclusion between CNA events in tumor clusters, which is helpful to analyze the potential interaction between genes in mutation. Last but not least, Ripley’s K-function is also applied to CNA multi-distance spatial pattern analysis so that we can figure out the differences of different gene CNA events in spatial distribution, which is helpful for tumor analysis and implementing more effective treatment measures based on spatial characteristics of genes.
Keywords: copy number alteration, HMM, variational graph convolutional autoencoder, spatial transcriptome
1. Introduction
Copy number alteration is one of the important characteristics of tumors. Theoretically, through the genome and transcriptome in the same cell, we can infer the molecular mechanism leading to the change in cell phenotypes and reconstruct the cell lineage tree to capture DNA mutation profiles obtained in the cell genome over time. Although many experts and scholars are committed to the research on the joint paired sequencing technology of DNA and RNA, it is still challenging to conduct high-throughput sequencing and unbiased analysis of DNA and RNA samples at the same time. Due to the technical barrier and sequencing cost, these sequencing technologies have not been widely developed. However, many existing studies have shown a positive correlation between the gene expression and gene copy number identified from DNA sequencing, providing a theoretical foundation for inferring the CNA of tumor cells from transcriptome data [1,2,3].
Nowadays, single-cell transcriptome sequencing has been widely used to analyze the heterogeneity in tumors [4,5]. Many tools based on transcriptome sequencing have also been developed to identify the changes in genomic copy numbers in cells. For example, inferCNV [6] identifies somatic large-scale chromosomal copy number alterations based on tumor scRNA-seq data through Bayesian and Hidden Markov Model (HMM) models. CaSpER [7] obtains profiles of cell genome copy numbers by combining gene expression and allele offset information. CopyKAT [8] uses the combination of GMM and chromosome breakpoint exploration with Markov Chain Monte Carlo to generate cell CNA profiles.
As we all know, traditional transcriptome sequencing will lead to the loss of cellular spatial information and destruction of the tumor microenvironment. In the molecular level analysis of genomics, tumor cells of the same clone exhibit local aggregation characteristics spatially, and the physical location of cells facilitates the analysis of tissue functions and corresponding pathological changes. In order to solve the spatial problem in gene sequencing, spatial transcriptome analysis technology has been developed in recent years [9]. We can not only analyze the spatial consistency and heterogeneity of tumor cells morphologically but can also explore the polyclonal characteristics of tumor cells and spatially related genes at the molecular level [10,11,12,13]. At present, there are still few tools for CNA inference for spatial transcriptome data. Although STARCH [14] integrates spatial information into CNA inference through HMRF, it can only infer the consistent CNA profile of each clone instead of each spot in spatial transcriptome data. Therefore, it is urgent to develop new tools to identify genomic variation as well as integrate genetic and transcriptional variation based on the spatial transcriptome.
In this study, we propose a machine learning tool, CVAM, to infer CNA profiles from spatial transcriptome data. This method consists of clustering analysis and CNA inference stages. For clustering analysis, the spatial information and gene expression information are fused to realize nonlinear dimensionality reduction by variational graph autoencoder (VGAE) with multi-tasks. Then, the unsupervised clustering of samples is implemented by the Louvain algorithm. In the CNA inference stage, the CNA profile of each spot is inferred by the HMM after multi-level filters based on the cell type information from the first stage. Compared with other methods, CVAM improves the performance of CNA inference. We also analyze the CNA event patterns through Ripley’s K-function based on the CNA profiles. In summary, CVAM applies current popular machine learning algorithms to the analysis and prediction of spatial transcriptome data, expanding the use of biological information from spatial transcriptome data. Moreover, it further promotes the widespread applications of relevant machine-learning algorithms in bioinformatics.
2. Materials and Methods
In this study, we propose a machine learning tool CVAM to infer CNA profiles of spatial transcriptomic data (Figure 1). First, a simulation graph corresponding to the spatial transcriptomic data is constructed. Then the hidden layer representations of spots are learned through multi-task VGAE. Subsequently, the spots are divided into different clusters based on the learned representation. According to the clusters, HMM is used to infer the genomic CNA profile of each spot.
The generation of the simulation graph is based on the spatial information of each spot and the similarity between spots (see Modeling). Based on the adjacency matrix and standardized gene expression matrix, the nonlinear low-dimensional representations of spots are learned through variational inference with an autoencoder (Figure 2a). First, for the input simulated graph, the adjacency information and gene expression information are aggregated through a shared GCN network layer. Then, two GCN neural network modules are constructed to learn the mean and variance of multivariate normal distribution satisfied by each spot in the hidden space, respectively. Then, through the reparameterization trick, the hidden space representation of each spot is obtained. Based on the hidden representation , two fully connected neural network modules are constructed to reconstruct the gene expression matrix and adjacency matrix of the graph. The Louvain algorithm is used to classify spots. Figure 2b shows the CNA inference process. The gene expression data are re-sorted according to the position of genes in chromosomes. After multi-media filtering, the spots are grouped based on the clustering results and HMM is applied to the data. Finally, the output is the genome CNA profile of each spot.
2.1. Modeling
2.1.1. Construction of Graph
In order to introduce the spatial information of spots into the clustering, we construct the connection graph between spots according to the spatial coordinate information contained in the spatial transcriptome data and the similarity between spots. The graph is denoted by . We use to represent spots. First, we construct the graph through the k-nearest neighbor algorithm KNN and assign the weight to the edge with the connection between spots in the graph. Then, we calculate whether the connected spots are adjacent in spatial positions. If they are adjacent, is added to the weight of the edge. Finally, we construct the graph that integrates the spatial information and similar information of spots, and we use the adjacency matrix to represent the topology of each spot in the graph.
2.1.2. The Architecture of VGAE with Multi-Task
Firstly, for the input reprocessed gene expression data and the topological correlation adjacency matrix , we use a k-layer graph convolution neural network(GCN) to fuse the spatial information and features of spots, namely,
where is the symmetrically normalized adjacency matrix, and is the degree matrix, recording the number of neighbor spots connected to each spot. Through and , the mean and variance of the normal distribution satisfied by each dimension of each spot in the hidden layer space were inferred. To simplify the parameter quantity of the model, the two modules share the first layer network parameters, and only the second layer network parameters are different. Moreover, to make each inferred dimension meet the standard normal distribution as much as possible, we compute the KL divergence between the inferred distribution and the standard normal distribution and add it to the loss function of the entire model for training and optimization. With the and , we can generate the corresponding low-dimension representation of each spot through the reparameterization trick; here, is the dimension of the hidden space. The formula can be represented as:
For the hidden representation , we construct two fully connected neural network models respectively to accomplish two tasks (reconstruct the features of the spots and the spatial topology information):
On the one hand, it is to make the generated adjacency matrix as similar as the input adjacency matrix if possible, that is, through , the original spatial topology of the spatial transcriptome can be reconstructed as possible. In addition, we measure the difference between the generated matrix and the original matrix through BCE loss. On the other hand, with a network , the gene expression matrix can be reconstructed, and we use MSE loss to measure the difference between the generated gene expression matrix and the input gene expression matrix . Compared with the decoder part of the traditional VGAE model, the reconstruction ability of our generated model is more robust.
2.1.3. Loss Function
In order to balance the training loss of KL divergence and the reconstruction in the model, make the loss of them is made comparable, and avoid training the over-fitting model, we add a weight to each loss part to regularize the loss value, respectively. The loss function can be expressed as:
namely,
Finally, based on the Adam optimizer in Pytorch, the parameters are optimized by iteratively training the model through the back-propagation algorithm.
2.1.4. Hidden Markov Model
After obtaining the hidden representation of each spot through the VGAE model, we use the Louvain algorithm to realize the unsupervised clustering of spots. After clustering, we use the Hidden Markov Model with multi-level filters to infer the CNA profile of each spot. First, we used a preprocessed gene expression matrix according to the position of genes on the chromosome. The p-arm and q-arm of each chromosome is regarded as an independent sequence, and is used to represent the expression value of genes arranged along the p-arm or q-arm of a chromosome in the spot. For each sequence, we apply the median filter with window size to smooth along the sequence. In order to reduce the dependence of and improve the stability and effectiveness of the median filters, we use multi-level median filters to filter the initial gene expression sequence. Then, a median filter is used on these results after multi-level filters. Finally, HMM is used to infer the CNA profile by cluster based on clustering information. In this study, we mainly define three CNA states, including deletion, neutral, and amplification. Deletion means the gene copy number is 0 or 1. Neutral means diploid, while amplification means the gene copy number is more than two. We use to denote the gene CNA state along the sequence. is the transition probability matrix between the three states. The emission probabilities of the three states meet the normal distribution with the mean value and variance , namely, . In addition, is the initial probability distribution of each state. The CNA states follow a first-order Markov chain and the CNA state of the current gene is only determined by the CNA state of the previous one, that is
Therefore, the probability model of under parameters in the HMM is expressed as:
Next, the iterative solution of the model parameters can be realized by the Baum–Welch algorithm. Based on the estimated model parameters, the CNA profile , which corresponds to the input gene expression value sequence , can be inferred by the Viterbi algorithm.
2.2. Multi-Distance Spatial Pattern Analysis of CNA Event
In order to analyze the relationship between the CNA event and space, for the CNA profile of a gene in space, Ripley’s K-function is used to analyze the spatial point pattern of the CNA event from multi-distance. Ripley’s K-function is an index to describe the spatial structure of point processes under isotropic and mean conditions from multi-distance [15]. For a certain gene, each spot with CNA event of the gene is selected. As for these spots, the number of spots with the same CNA event in a circle with a radius can be computed. Then, the results of all spots are summed up and divided by the total number of spots with CNA events as well as the density of the CNA event in the whole space. Namely:
Here, is the number of spots with CNA events in the space and is the point density of the space.
The patterns of CNA events mainly include aggregation and dispersed and complete spatial randomness (CSR). To compute the pattern to which the CNA events of genes belong, we random samples spots in the space 1000 times so that the expected value of K-function from multi-distance can be calculated. Then, two null hypotheses are established as follows.
If the first is rejected, the CNA event of genes is a dispersed pattern. If the second one is rejected, the CNA event of genes is an aggregation pattern. Otherwise, the CNA event of genes is a complete spatial randomness (CSR) pattern, which indicates that CNA events occur randomly in the whole space without spatial correlation.
2.3. Proof with Simulation and Actual Data
Two simulated and four real spatial transcriptome data were used in our experiments. For the simulation datasets, we first selected breast cancer data obtained by G&T-seq [16], which contains both DNA and transcriptomic data from the breast cancer line HCC38. We calculated the CNA profiles based on genomic DNA by cyclic binary segmentation (CBS) analysis [17] and obtained the CNA status of each gene on the chromosome segment based on the CNA results. We used the CNA results for each gene as our ground truth. The second simulation dataset is from the bulk data of relevant tumor cells in TCGA. The DNA and transcriptome of the same tissue sample of the same patient were sequenced separately. The method used for obtaining ground truth was the same as the previous experiment. The spatial distribution corresponding to each sample of these datasets is generated by the novoSpaRc [18] method (Supplementary Note S1). The four real spatial transcriptome data include human breast cancer, skin squamous cell carcinoma, head and neck square cell carcinoma and lung cancer based on the mouse genome. The data preprocessing is in Supplementary Note S2.
3. Results
3.1. Applying CVAM to High-Resolution Simulated Spatial Transcriptomic Data
We applied CVAM to the simulated spatial transcriptome data based on the breast cancer line HCC38 and the B lymphoblastoid line HCC38-BL from G&T-seq (Figure 3). Compared with the other three tools, CVAM improves the TPR (61.09% TPR of deletion and 62.51% TPR of amplification) of inferring CNA events (Figure 3b and Table S1). Moreover, the visual presentation of © profiles (Figure 3a) suggests that the inference results of CVAM are closer to the ground truth. In addition, we also tested the impact of different clustering methods on the clustering results (Figure 3c, Supplementary Figure S1). Through the Adjusted Rand Index (ARI), Normalized Mutual Information (NMI) and Adjusted Mutual Information (AMI), whose definition and computation are shown in Supplementary Note S3, we can find that the CVAM with the Louvain algorithm performs better than others. CVAM utilizes VGAE to perform nonlinear dimensionality reduction on gene expression matrices. Compared with Seurat’s PCA linear dimensionality reduction, CVAM has a better generalization ability. In addition, before using the Louvain unsupervised algorithm for clustering, Seurat only used the KNN algorithm to construct the graph. In contrast, CVAM further uses the coordinate information of each spot in the actual space to correct the graph so that the gene expression is similar and the adjacent spots in the space are more closely connected in the graph, thereby improving the clustering performance.
3.2. Applying CVAM to Simulated Spatial Transcriptome Data from Bulk RNA-Seq
We also applied CVAM to the simulated spatial transcriptome data from bulk RNA-seq (Figure 4). Figure 4a shows the spatial distribution profile of the simulation data and the clustering results. In this dataset, CVAM achieves 70.75% TPR with 15.24% FPR in gene deletions and 63.79% TPR with 19.46% FPR in gene amplifications (Figure 4b and Table S2). In order to explore the influence of spot size on the results. We randomly sampled datasets with different spot sizes and conducted experiments separately. The results are shown in Figure 4c. We can see that as the spot size continues to increase, TPR and FPR both show an upward trend. However, the trend of changes in TPR and FPR of CNA is not significant. As the spot size increases, HMM’s transfer probability and emission probability become more accurate. However, due to the high degree of convergence of model parameter training, it has little impact on the final results. In addition, the increase in spot size also leads to an increase in outliers. However, the multi-scale median filtering smooths the abnormal mutation values of gene expression and improves the model robustness so that the results are not worsened. These experiments have shown that spot size has relatively little influence on the results, reflecting the universal application of our method under different spot sizes. In addition, we also compared the performance under the different scales of multi-level median filters (Figure 4d). At smaller scales, the model has limited ability to identify CNA events, while the performance is better at a large scale.
3.3. Applying CVAM to the Spatial Transcriptome Data of Breast Cancer
We apply CVAM to analyze the spatial transcriptome data of breast cancer (Figure 5). The spots in this dataset are mainly divided into five clusters (Figure 5b). Analyzing the marker genes [19] in each cluster, we find that cluster 3 and cluster 5 are tumor cell clusters. The CNA profiles show that high-frequency CNA events mainly occur in clusters 3 and 5 (Figure 5a). In the two clusters, S100A4, ERBB2, KRT19 and other genes have occurred copy number amplification, while ACTA2, FBN1, ID2 and other genes have occurred copy number deletion. These results have been recorded in detail in the cBioPortal [20] database related to breast cancer. In addition, CNA distributions also show that the spots belonging to cluster 3 or cluster 5 are more different from the normal spots (Figure 5c). By comparing the co-occurrence and mutually exclusive analyses of cluster 3 and cluster 5, we can also find the potential relevance of CNA between genes in different clusters (Figure 5d). For example, the amplification of S100A4 and the amplification of KRT81 exhibit a co-occurrence relationship in both clusters, indicating that they have a common impact on tumor development and that there is a potential concomitant occurrence between the two genes. In the spatial pattern, it can be found that the genes such as S100A4 show an aggregation pattern (d = 4, p < 1 × 10−38) while ID2 shows a dispersed pattern (d = 4, p < 1 × 10−5) and FBN1 shows a complete spatial randomness pattern (Figure 5e). This reflects the differences in CNA spatial patterns among different genes, which can help implement more effective treatment plans for the spatial characteristics of different genes in the future.
3.4. Applying CVAM to the Spatial Transcriptome Data of Skin Squamous Cell Carcinoma
We also apply CVAM to a spatial transcriptomic dataset of human skin squamous cell carcinoma (Figure 6a). Similarly, we found that genes such as CD7, CD1A, and HLA-DPB1 experienced significant copy number amplification, while genes such as CD3E experienced significant copy number deletion. These results also can be found in the cBioPortal. Moreover, the co-occurrence and mutual exclusion of genes CNA states also can be found. The pairs such as HLA-DRB1-amp/PDGFRB-amp showed co-occurrence in cluster 1 (p < 1 × 10−5), while pairs such as BRD4-del/KLF2-amp show a mutually exclusive (p < 1 × 10−5). Finally, we also found genes with CNA event spatial patterns. Genes such as EIF1AD present CRS patterns on a small scale, indicating that CNA events for such genes exhibit randomness in local space. As the region expands, the observed K-value is above the expected K-value, which reflects the CNA events showing that aggregation patterns occur more intensively (Figure 6c).
3.5. Applying CVAM to the Spatial Transcriptome Data of Head and Neck Square Cell Carcinoma
In order to test the performance of our method on different sequencing platforms, we also applied CVAM to the spatial transcriptome data of head and neck square cell carcinoma based on digital spatial profiling (DSP) of Nanostring (Figure 6d). We observed a large number of CNA amplifications in genes such as S100A11, S100A2, KRT16, and KRT17 in cluster 2 and cluster 3, while genes such as KRT78, IGHG4, and IGHG2 exhibited a large number of CNA deletion events. They are consistent with the results in the cBioPortal. Through co-occurrence and mutual exclusion, we found that the two clusters have some differences in CNAs; for example, S100A12 and S100A16 amplifications significantly co-occurred in cluster 3 (p < 1 × 10−3, FDR < 0.05), while no correlation was found in cluster 2. However, in cluster 2, the amplifications of S100A10 and AHNAK genes were significantly co-occurrence (p < 1 × 10−3, FDR < 1 × 10−2). Both genes participated in the regulation of cell membrane cytoarchitecture [21], which also reflected the CNA differences between clusters (Figure 6e).
3.6. Applying CVAM to the Spatial Transcriptome Data of Lung Cancer
We also apply CVAM to a spatial transcriptomic dataset of lung cancer based on a mouse model (Figure 7). The CNA results and clustering results are shown in Figure 7a and Figure 7b, respectively. It can be found that genes such as S100a6, S100a8, and S100a9 showed significant amplification in cluster 3. These genes were reported to be highly expressed in lung cancer in the previous studies [22,23], which may be due to copy number amplification leading to tumor growth and metastasis in related cancer cells. In addition, through the co-occurrence and mutual exclusion analysis (Figure 7c), we also found that the amplification of S100a8 and S100a9 exhibits a co-occurrence relationship (p < 1 × 10−79). The consistent impact of these two genes on lung cancer metastasis has also been reported in a previous study [24]. In terms of spatial pattern, we found that the CNAs of S100a8 and S100a9 both exhibit aggregation patterns locally (d = 50, p < 1 × 10−5) and mainly aggregate in cluster 3 (Figure 7d). From global space, it is more inclined towards a discrete distribution pattern (d = 150, p < 1 × 10−20). In particular, from the figure below, we can also find some copy number deletion spots in the tissue, because these spots are mainly located in the cytoplasm or ST sequencing background region, and the measured gene expression values are much smaller than that of normal cells.
4. Discussion
The CNA profile plays an important role in the analysis of polyclonal characteristics of tumor cells. We propose a CNA profile inference tool, CVAM, for analyzing genetic variants from spatial transcriptome data. We first cluster the samples based on the feature similarity and spatial characteristics through VGAE. Compared with the traditional PCA linear dimension reduction, the generalization ability of CVAM is higher and the samples can be divided more correctly. In addition, compared with the simple VAE [25,26], VGAE integrates spatial information with the spot’s gene expression information together so that the heterogeneous information of samples can be analyzed, which is conducive to the unsupervised clustering between adjacent spots.
In CNA inference, multi-level filters can remove the interference of outliers and the window size of filters. Compared with CaSpER, CVAM performs multi-scale integration before HMM, which reduces the time cost of model training. Although inferCNV using Bayesian and HMM performs relatively well, it only performs better on consistent CNA inference under a large number of samples, and the performance on higher-resolution data remains to be improved. Compared with these existing tools, our experimental results demonstrate that CVAM performs better in terms of accuracy and TPR for CNA events. In addition, although our tool is developed for spatial transcriptome data, after reconstructing the spatial distribution of samples through an optimal transmission algorithm, this method is also applicable to single cells or bulk transcriptome sequencing data. Moreover, through co-occurrence and mutual exclusion analysis, more and more potential connections between genes will be revealed, which will help us to further explore the molecular mechanism of tumor development and variation. Last but not least, gene spatial pattern analysis is one of the most important analysis methods in bioinformatics after the emergence of the spatial transcriptome. With the continuous development of spatial transcriptome technology, there will be more and more exploration of the spatial characteristics of tumor development in the future, which is important for the design of drugs and treatment plans.
There are also some limitations and shortcomings in the CVAM. The results are gene-level CNA profiles. So, the resolution of CNA can be further improved. Moreover, the number of states of CNA can increase, making the measurement of CNA events more detailed. In future works, we will further explore the detailed and effective division of chromosome sequence so that the resolution and accuracy of this method can be improved.
With the development of slide-DNA-seq [27] that can capture spatially resolved DNA sequences, it is believed that more research will be devoted to the joint analysis of spatial transcriptome and genome data in the future. This will help to further understand the heterogeneity of tumors and provide some auxiliary decision-making for the precise treatment of related tumor diseases.
Acknowledgments
The authors thank College of Electronic and Information Engineering of Tongji University for providing the computing platform. The funders had no role in study design, data collection and analysis, decision to publish or preparation of the manuscript.
Supplementary Materials
The following supporting information can be downloaded at: https://www.mdpi.com/article/10.3390/biom13050767/s1, Note S1: Generation of simulation spatial transcriptome data; Note S2: Gene expression data preprocessing; Note S3: Evaluation; Figure S1: The clustering distribution of spots under different clustering algorithms; Table S1: The evaluation result of CVAM on high-resolution simulated spatial transcriptome; Table S2: The evaluation result of CVAM on simulate spatial transcriptome data from bulk RNA-seq.
Author Contributions
Conceptualization, J.G.; Methodology, Z.F. and X.Z.; Software, J.M.; Writing—original draft, J.M.; Writing—review & editing, W.Z.; Project administration, X.Z. All authors have read and agreed to the published version of the manuscript.
Institutional Review Board Statement
Not applicable.
Informed Consent Statement
Not applicable.
Data Availability Statement
All the data in this paper are publicly available. The G&T-seq data are derived from [16]. Normal breast single-cell data can be accessed from the Gene Expression Omnibus (GEO) databases with accession numbers GSE113197. Pan-cancer data are derived from [28] and the normal breast bulk RNA-seq data can be accessed from TCGA-BRCA. The spatial transcriptome data of breast cancer are from [29], the spatial transcriptome data of skin squamous cell carcinoma are from [30], the spatial transcriptome data of head and neck squamous cell carcinoma are from [31] and the spatial transcriptome data of lung cancer are from [32]. Code availability: CVAM is written in Python language (v3.8.5). The code has been open source and analysis results are listed publicly at GitHub: https://github.com/JMnotDGR/CVAM (accessed on 25 April 2023).
Conflicts of Interest
The authors declare no competing interests.
Funding Statement
Ma was supported by the 1·3·5 projects for disciplines of excellence–Clinical Research Incubation (2019HXFH022) and disciplines of excellence (ZYJC18010), West China Hospital, Sichuan University. Guo was supported by Sichuan Science and Technology Program, (2022YFS0228). Fan, Zhao, and Zhou were supported by R01CA241930, U01AR069395, R01GM123037, and NSF2217515.
Footnotes
Disclaimer/Publisher’s Note: The statements, opinions and data contained in all publications are solely those of the individual author(s) and contributor(s) and not of MDPI and/or the editor(s). MDPI and/or the editor(s) disclaim responsibility for any injury to people or property resulting from any ideas, methods, instructions or products referred to in the content.
References
- 1.Sun W., Bunn P., Jin C., Little P., Zhabotynsky V., Perou C.M., Hayes D.N., Chen M., Lin D.-Y. The association between copy number aberration, DNA methylation and gene expression in tumor samples. Nucleic Acids Res. 2018;46:3009–3018. doi: 10.1093/nar/gky131. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 2.Shao X., Lv N., Liao J., Long J., Xue R., Ai N., Xu D., Fan X. Copy number variation is highly correlated with differential gene expression: A pan-cancer study. BMC Med. Genet. 2019;20:175. doi: 10.1186/s12881-019-0909-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3.Yang S.Y., Castellani C.A., Longchamps R.J., Pillalamarri V.K., O’Rourke B., Guallar E., Arking D.E. Blood-derived mitochondrial DNA copy number is associated with gene expression across multiple tissues and is predictive for incident neurodegenerative disease. Genome Res. 2021;31:349–358. doi: 10.1101/gr.269381.120. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.Stark R., Grzelak M., Hadfield J. RNA sequencing: The teenage years. Nat. Rev. Genet. 2019;20:631–656. doi: 10.1038/s41576-019-0150-2. [DOI] [PubMed] [Google Scholar]
- 5.Peng J., Sun B.-F., Chen C.-Y., Zhou J.-Y., Chen Y.-S., Chen H., Liu L., Huang D., Jiang J., Cui G.-S., et al. Single-cell RNA-seq highlights intra-tumoral heterogeneity and malignant progression in pancreatic ductal adenocarcinoma. Cell Res. 2019;29:725–738. doi: 10.1038/s41422-019-0195-y. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6.Patel A.P., Tirosh I., Trombetta J.J., Shalek A.K., Gillespie S.M., Wakimoto H., Cahill D.P., Nahed B.V., Curry W.T., Martuza R.L., et al. Single-cell RNA-seq highlights intratumoral heterogeneity in primary glioblastoma. Science. 2014;344:1396–1401. doi: 10.1126/science.1254257. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7.Serin Harmanci A., Harmanci A.O., Zhou X. CaSpER identifies and visualizes CNV events by integrative analysis of single-cell or bulk RNA-sequencing data. Nat. Commun. 2020;11:89. doi: 10.1038/s41467-019-13779-x. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8.Gao R., Bai S., Henderson Y.C., Lin Y., Schalck A., Yan Y., Kumar T., Hu M., Sei E., Davis A., et al. Delineating copy number and clonal substructure in human tumors from single-cell transcriptomes. Nat. Biotechnol. 2021;39:599–608. doi: 10.1038/s41587-020-00795-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Moses L., Pachter L. Museum of spatial transcriptomics. Nat. Methods. 2022;5:534–546. doi: 10.1038/s41592-022-01409-2. [DOI] [PubMed] [Google Scholar]
- 10.Bassiouni R., Gibbs L.D., Craig D.W., Carpten J.D., McEachron T.A. Applicability of spatial transcriptional profiling to cancer research. Mol. Cell. 2021;81:1631–1639. doi: 10.1016/j.molcel.2021.03.016. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Moncada R., Barkley D., Wagner F., Chiodin M., Devlin J.C., Baron M., Hajdu C.H., Simeone D.M., Yanai I. Integrating microarray-based spatial transcriptomics and single-cell RNA-seq reveals tissue architecture in pancreatic ductal adenocarcinomas. Nat. Biotechnol. 2020;38:333–342. doi: 10.1038/s41587-019-0392-8. [DOI] [PubMed] [Google Scholar]
- 12.Song Q., Su J. DSTG: Deconvoluting spatial transcriptomics data through graph-based artificial intelligence. Brief. Bioinform. 2021;22:bbaa414. doi: 10.1093/bib/bbaa414. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13.Sun S., Zhu J., Zhou X. Statistical analysis of spatial expression patterns for spatially resolved transcriptomic studies. Nat. Methods. 2020;17:193–200. doi: 10.1038/s41592-019-0701-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Elyanow R., Zeira R., Land M., Raphael B.J. STARCH: Copy number and clone inference from spatial transcriptomics data. Phys. Biol. 2021;18:35001–35011. doi: 10.1088/1478-3975/abbe99. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Shakiba M., Lake L.W., Gale J.F., Pyrcz M.J. Multiscale spatial analysis of fracture arrangement and pattern reconstruction using Ripley’s K-function. J. Struct. Geol. 2022;2:104531. doi: 10.1016/j.jsg.2022.104531. [DOI] [Google Scholar]
- 16.Macaulay I., Haerty W., Kumar P., Li Y., Hu T.X., Teng M.J., Goolam M., Saurat N., Coupland P., Shirley L.M., et al. G&T-seq: Parallel sequencing of single-cell genomes and transcriptomes. Nat. Methods. 2015;12:519–522. doi: 10.1038/nmeth.3370. [DOI] [PubMed] [Google Scholar]
- 17.Olshen A.B., Venkatraman E.S., Lucito R., Wigler M. Circular binary segmentation for the analysis of array-based DNA copy number data. Biostatistics. 2004;5:557–572. doi: 10.1093/biostatistics/kxh008. [DOI] [PubMed] [Google Scholar]
- 18.Nitzan M., Karaiskos N., Friedman N., Rajewsky N. Gene expression cartography. Nature. 2019;576:132–137. doi: 10.1038/s41586-019-1773-3. [DOI] [PubMed] [Google Scholar]
- 19.Hu C., Li T., Xu Y., Zhang X., Li F., Bai J., Zhang Y. CellMarker 2.0: An updated database of manually curated cell markers in human/mouse and web tools based on scRNA-seq data. Nucleic Acids Res. 2023;51:D870–D876. doi: 10.1093/nar/gkac947. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20.Cerami E., Gao J., Dogrusoz U., Gross B.E., Sumer S.O., Aksoy B.A., Jacobsen A., Byrne C.J., Heuer M.L., Larsson E., et al. The cBio cancer genomics portal: An open platform for exploring multidimensional cancer genomics data. Cancer Discov. 2012;2:401–404. doi: 10.1158/2159-8290.CD-12-0095. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21.Benaud C., Gentil B.J., Assard N., Court M., Garin J., Delphin C., Baudier J. AHNAK interaction with the annexin 2/S100A10 complex regulates cell membrane cytoarchitecture. J. Cell Biol. 2004;164:133–144. doi: 10.1083/jcb.200307098. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22.Ortiz M.L., Lu L., Ramachandran I., Gabrilovich D.I. Myeloid-Derived Suppressor Cells in the Development of Lung Cancer. Cancer Immunol. Res. 2014;2:50–58. doi: 10.1158/2326-6066.CIR-13-0129. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.Bresnick A.R., Weber D.J., Zimmer D.B. S100 proteins in cancer. Nat. Rev. Cancer. 2015;15:96–109. doi: 10.1038/nrc3893. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 24.Hiratsuka S., Watanabe A., Aburatani H., Maru Y. Tumour-mediated upregulation of chemoattractants and recruitment of myeloid cells predetermines lung metastasis. Nature. 2006;12:1369–1375. doi: 10.1038/ncb1507. [DOI] [PubMed] [Google Scholar]
- 25.Blei D.M., Kucukelbir A., McAuliffe J.D. Variational Inference: A Review for Statisticians. J. Am. Stat. Assoc. 2017;112:859–887. doi: 10.1080/01621459.2017.1285773. [DOI] [Google Scholar]
- 26.Way G.P., Greene C.S. Extracting a biologically relevant latent space from cancer transcriptomes with variational autoencoders. Proc. Pac. Symp. 2018;23:80–91. [PMC free article] [PubMed] [Google Scholar]
- 27.Zhao T., Chiang Z.D., Morriss J.W., LaFave L.M., Murray E.M., Del Priore I., Meli K., Lareau C.A., Nadaf N.M., Li J., et al. Spatial genomics enables multi-modal study of clonal heterogeneity in tissues. Nature. 2021;601:85–91. doi: 10.1038/s41586-021-04217-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 28.Taylor A.M., Shih J., Ha G., Gao G.F., Zhang X., Berger A.C., Schumacher S.E., Wang C., Hu H., Liu J., et al. Genomic and Functional Approaches to Understanding Cancer Aneuploidy. Cancer Cell. 2018;33:676–689.e3. doi: 10.1016/j.ccell.2018.03.007. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 29.Ståhl P.L., Salmén F., Vickovic S., Lundmark A., Navarro J.F., Magnusson J., Giacomello S., Asp M., Westholm J.O., Huss M., et al. Visualization and analysis of gene expression in tissue sections by spatial transcriptomics. Science. 2016;353:78–82. doi: 10.1126/science.aaf2403. [DOI] [PubMed] [Google Scholar]
- 30.Ji A.L., Rubin A.J., Thrane K., Jiang S., Reynolds D.L., Meyers R.M., Guo M.G., George B.M., Mollbrink A., Bergenstråhle J., et al. Multimodal Analysis of Composition and Spatial Architecture in Human Squamous Cell Carcinoma. Cell. 2020;182:497–514.e22. doi: 10.1016/j.cell.2020.05.039. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 31.Gavrielatou N., Vathiotis I.A., Aung T.N., Shafi S., Burela S., Fernandez A.I., Moutafi M., Burtness B.A., Economopoulou P., Anastasiou M., et al. Digital Spatial Profiling Links Beta-2-microglobulin Expression with Immune Checkpoint Blockade Outcomes in Head and Neck Squamous Cell Carcinoma. Cancer Res. Commun. 2023;3:558–563. doi: 10.1158/2767-9764.CRC-22-0299. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 32.Dhainaut M., Rose S.A., Akturk G., Wroblewska A., Nielsen S.R., Park E.S., Brown B.D. Spatial CRISPR genomics identifies regulators of the tumor microenvironment. Cell. 2022;185:1223–1239.e20. doi: 10.1016/j.cell.2022.02.015. [DOI] [PMC free article] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
All the data in this paper are publicly available. The G&T-seq data are derived from [16]. Normal breast single-cell data can be accessed from the Gene Expression Omnibus (GEO) databases with accession numbers GSE113197. Pan-cancer data are derived from [28] and the normal breast bulk RNA-seq data can be accessed from TCGA-BRCA. The spatial transcriptome data of breast cancer are from [29], the spatial transcriptome data of skin squamous cell carcinoma are from [30], the spatial transcriptome data of head and neck squamous cell carcinoma are from [31] and the spatial transcriptome data of lung cancer are from [32]. Code availability: CVAM is written in Python language (v3.8.5). The code has been open source and analysis results are listed publicly at GitHub: https://github.com/JMnotDGR/CVAM (accessed on 25 April 2023).