Skip to main content
Bioinformatics logoLink to Bioinformatics
. 2020 Jul 13;36(Suppl 1):i48–i56. doi: 10.1093/bioinformatics/btaa443

Unsupervised topological alignment for single-cell multi-omics integration

Kai Cao b1,b2, Xiangqi Bai b1,b2, Yiguang Hong b1,b2, Lin Wan b1,b2,
PMCID: PMC7355262  PMID: 32657382

Abstract

Motivation

Single-cell multi-omics data provide a comprehensive molecular view of cells. However, single-cell multi-omics datasets consist of unpaired cells measured with distinct unmatched features across modalities, making data integration challenging.

Results

In this study, we present a novel algorithm, termed UnionCom, for the unsupervised topological alignment of single-cell multi-omics integration. UnionCom does not require any correspondence information, either among cells or among features. It first embeds the intrinsic low-dimensional structure of each single-cell dataset into a distance matrix of cells within the same dataset and then aligns the cells across single-cell multi-omics datasets by matching the distance matrices via a matrix optimization method. Finally, it projects the distinct unmatched features across single-cell datasets into a common embedding space for feature comparability of the aligned cells. To match the complex non-linear geometrical distorted low-dimensional structures across datasets, UnionCom proposes and adjusts a global scaling parameter on distance matrices for aligning similar topological structures. It does not require one-to-one correspondence among cells across datasets, and it can accommodate samples with dataset-specific cell types. UnionCom outperforms state-of-the-art methods on both simulated and real single-cell multi-omics datasets. UnionCom is robust to parameter choices, as well as subsampling of features.

Availability and implementation

UnionCom software is available at https://github.com/caokai1073/UnionCom.

Supplementary information

Supplementary data are available at Bioinformatics online.

1 Introduction

The advent of single-cell sequencing provides high-resolution omics profiles at cellular level [e.g. single-cell DNA-sequencing of genomics, single-cell RNA-sequencing (scRNA-seq) of transcriptomes, single-cell sequencing of chromatin accessibility (ATAC)], offering the opportunity to unveil molecular mechanisms related to fundamental biological questions, such as cell fate decisions (Tanay and Regev, 2017). Although extensive studies have been conducted on the computational analysis of single-cell genomic, transcriptomic and epigenetic data, most methods are limited to handling single-cell data in one modality, yielding a series of separated and patched views of the intrinsic biological processes. Recently, single-cell multi-omics data across modalities profiled from cells sampled from the same sample or tissue are emerging. Integration of single-cell multi-omics data will build connections across modalities, providing a much more comprehensive molecular multi-view of intrinsic biological processes (Efremova and Teichmann, 2020; Stuart and Satija, 2019).

The integration of single-cell omics datasets is drawing heavy attention on advances in machine-learning and data science (Efremova and Teichmann, 2020; Stuart and Satija, 2019). Many single-cell data integration methods have been developed for the batch-effect correction of single-cell datasets in one modality (Stuart and Satija, 2019). However, compared with the single-cell batch-effect correction problem, the integration of single-cell multi-omics datasets across modalities poses fresh challenges in two ways. First, single-cell multi-omics datasets consist of unpaired cells measured with distinct unmatched features across modalities (Stuart and Satija, 2019). As most single-cell sequencing assays are still destructive for cells, single-cell datasets of either the same modality or different modalities generally have unpaired cells. Moreover, single-cell multi-omics datasets do not share common features across modalities, since each modality is aimed at acquisition of cellular molecular identity from a particular aspect. The distinct features across modalities reside in different mathematical spaces. Generally, therefore, single-cell multi-omics data do not have any correspondences, either among samples (cells) or among features. In practice, empirical pre-matching of distinct features across modalities into a common space based on prior knowledge is generally taken prior to applying state-of-the-art single-cell data integration methods. Second, single-cell multi-omics data are generated by different assays, with distinct underlying data generative models and mechanisms. Therefore, complex non-linear geometrical distortions on datasets across modalities can be introduced to the biological intrinsic low-dimensional structures. Such complex distortions make the integration of single-cell multi-omics data much more difficult than batch-effect correction for single-cell datasets in one modality. Therefore, linear operations, such as translation and scaling, which generally work well for batch-effect correction of single-cell datasets in one modality, are now inadequate for the alignment of single-cell multi-omics datasets with complex non-linear geometrical distortions across modalities.

Computational methods have been developed for single-cell data integration. However, many existing methods were designed for batch-effect correction (Stuart and Satija, 2019). The challenges of single-cell multi-omics integration arise as a result of distinct unmatched features, as well as complex non-linear geometrical distortions across modalities, and these problems remain unresolved. The pioneering single-cell data integration method, mutual nearest neighbor (MNN; Haghverdi et al., 2018), aimed to remove batch effects across datasets by aligning MNNs, as calculated by the Euclidean distances between cells across datasets in a common feature space. However, MNN is restricted to cases in which batch effect is almost orthogonal to the biological subspace and cases in which batch-effect variation is much smaller than biological-effect variation between different cell types (Haghverdi et al., 2018). The established single-cell data analysis pipeline, Seurat (Stuart et al., 2019), projected (distinct) feature spaces across datasets using canonical correlation analysis (CCA) into a common subspace which maximizes the inter-dataset correlation structure, and then adopted a strategy similar to that of MNN to align the cells between datasets by finding anchor cells (i.e. corresponding points) across datasets based on the MNNs calculated from the projected common subspace. However, since CCA is a linear dimensionality reduction method, it cannot capture the non-linear inter-relationships among single-cell multi-omics data across modalities. Scanorama (Hie et al., 2019) was built upon the MNN-based strategy for the computationally efficient integration of many large-scale scRNA-seq datasets. scAlign (Johansen and Quon, 2019) developed a deep autoencoder-based approach for the non-linear dimensionality reduction of shared common feature space across one-modality scRNA-seq datasets and then aligned cells across datasets. Harmony (Korsunsky et al., 2019) projected cells into a shared embedding using principal components analysis (PCA), and iterated between two complementary stages to simultaneously account for multiple experimental and biological factors.

Methods developed for single-cell multi-omics integration across modalities are emerging. Liger (Welch et al., 2019), which worked on datasets with pre-matched common feature space across modalities, employed non-negative matrix factorization to find the shared low-dimension factors of the common features to match single-cell omics datasets. MATCHER (Welch et al., 2017) removed the requirement for correspondence information of features across modalities and integrated single-cell multi-omics datasets based on manifold alignment. However, MATCHER is limited to the alignment of 1D trajectories (Welch et al., 2017), but it is incapable of aligning complex trajectories, such as branched tree structures. MAGAN (Amodio and Krishnaswamy, 2018) integrated single-cell multi-omics datasets by aligning the biological manifolds via a generative adversarial networks approach. However, it lacked power in unsupervised task when the correspondence information among samples across datasets is unavailable (Liu et al., 2019). Harmonic (Stanley et al., 2018) aligned the diffusion geometries across datasets based on diffusion map method, but it required partial feature correspondence information. Maximum mean discrepancy-manifold alignment (MMD-MA; Liu et al., 2019), an unsupervised manifold alignment algorithm for single-cell multi-omics datasets, embedded the latent biological low-dimensional structures in Reproducing Kernel Hilbert spaces (RKHSs), and found a shared common subspace of the RKHSs for manifold alignment by minimizing the MMD across modalities.

In this study, we present a novel algorithm, termed UnionCom, for the unsupervised topological alignment of single-cell multi-omics integration. UnionCom is an unsupervised method which does not require any correspondence information, either among cells or among features, across single-cell multi-omics datasets. It extends the generalized unsupervised manifold alignment (GUMA) algorithm (Cui et al., 2014), which was originally applied to the 3D structure alignment of protein sequences, to tackle the difficulty in the topological alignment of complex non-linear distorted intrinsic low-dimensional structures embedded in the single-cell data. Specifically, UnionCom first embeds the intrinsic low-dimensional structure of each single-cell dataset into a distance matrix of cells within the same dataset and then aligns the cells across single-cell multi-omics datasets by matching the distance matrices via a matrix optimization method. Finally, it projects the distinct unmatched features across single-cell datasets into a common embedding space for feature comparability of the aligned cells (Fig. 1). UnionCom works on the general assumption that cells of single-cell multi-omics datasets are from similar cell populations sampled from similar biological processes or tissues with similar intrinsic low-dimensional structures embedded in the data. It does not require one-to-one correspondence among cells across datasets, and it can take care of samples with dataset-specific cell types.

Fig. 1.

Fig. 1.

Schematic overview of UnionCom. (a) Given the input of single-cell multi-omics datasets (e.g. Datasets 1 and 2), which have similar embedded topological structures, UnionCom (b) embeds the intrinsic low-dimensional structure of each single-cell dataset into a geometrical distance matrix of cells within the same dataset; (c) rescales the global distortions on the topological structures across datasets by a global scaling parameter α; (d) aligns the cells across single-cell datasets by matching the geometrical distance matrices based on a matrix optimization method; and (e) finally projects the distinct unmatched features across modalities into a common embedding space for feature comparability of the aligned cells. It does not require one-to-one correspondence among cells across datasets, and it can accommodate samples with dataset-specific cell types (see the branch with black points in Dataset 2 for example)

We demonstrate the power of UnionCom in unsupervised topological alignment for single-cell multi-omics integration, especially for complex intrinsic structure embeddings, using both simulated and real single-cell multi-omics datasets. When compared with state-of-the-art methods, UnionCom outperforms them with high accuracy. In addition, UnionCom is robust in terms of parameter choices, as well as subsampling of features.

2 Materials and methods

2.1 UnionCom algorithm

UnionCom is an unsupervised topological alignment algorithm for single-cell multi-omics integration (Fig. 1). We describe details of UnionCom as follows.

Here, we formulate our method for the case of two datasets. However, it can be easily generated for cases of any number of single-cell multi-omics datasets. Suppose we have two single-cell multi-omics datasets, X=[x1,,xnx]Rdx×nx and Y=[y1,,yny]Rdy×ny, across two modalities where dx(dy) and nx(ny) are the number of features (e.g. gene expression, DNA methylation) and cells for the X(Y), respectively. Without loss of generality, we assume that nxny. We assume that the intrinsic low-dimensional manifolds of X and Y are Mx and My, respectively, which share similar topological structure. Given the input of X and Y, UnionCom aligns the cells between the datasets and then projects the distinct unmatched features into a common embedding space as the coordinates of the aligned cells between datasets. UnionCom consists of the following three major Steps (A1–A3).

A1. Embedding the intrinsic low-dimensional structure of each single-cell dataset into the geometrical distance matrix

UnionCom embeds the intrinsic low-dimensional structure of each single-cell dataset into a metric space by using the geometrical distance matrix of the cells within the same dataset which is defined as [K]ij=d(xi,xj), where d is a geodesic distance between cells on the intrinsic manifold. Accordingly, Kx and Ky represent geometrical distance matrices for Mx and My, respectively. To calculate the geodesic distance, UnionCom first constructs a weighted k nearest neighbor graph of cells for each dataset based on Euclidean distance, and then calculates the shortest distance between each pair of nodes (cells) on the graph using the Floyd–Warshall algorithm since the shortest distance path will approximate to geodesic distance (Tenenbaum et al., 2000). We set k to be the minimum number that makes k-nn graph connected. We demonstrate that UnionCom is robust to the choices of k in a wide range (Fig. 6b).

Fig. 6.

Fig. 6.

The robustness of UnionCom in both subsampling features of data and parameter choices on the two sc-NMT datasets of DNA methylation and chromatin accessibility. (a) Label Transfer Accuracy of UnionCom, Seurat, MMD-MA and Harmony when randomly sampling a subset of features without replacement from each of the DNA accessibility and chromatin methylation datasets separately before alignment. (b) Label Transfer Accuracy of UnionCom when choosing different k of the k-nn graph in Step A1 of UnionCom. (c) The convergence performance of UnionCom in training loss using different ρ for the penalty term in Equation (2); when ρ = 0, no penalty term is applied in Equation (2). (d) Label Transfer Accuracy of UnionCom when choosing different ρ. (e) Label Transfer Accuracy of UnionCom when choosing different tradeoff parameter β in Equation (3). (f) Label Transfer Accuracy of UnionCom when embedding the two datasets into a common space of different dimensionality of p in Step A3 of UnionCom

A2. Aligning cells across single-cell multi-omics datasets by matching the geometrical distance matrices

UnionCom aligns cells across single-cell datasets by matching the geometrical distance matrices. By extending the unsupervised manifold alignment algorithm GUMA (Cui et al., 2014), UnionCom proposes and adjusts a global scaling parameter α in Equation (1) for rescaling the global geometrical distortions for the topological structure alignment across datasets. In addition, UnionCom relaxes the restriction of one-to-one cell correspondence required by GUMA. It is capable of handling samples with dataset-specific cell types.

Specifically, UnionCom formalizes the unsupervised topological alignment problem into a matrix optimization problem as follows:

minF,α||α1nx×nyKxFKyF||F2,

where F=[Fij]nx×ny is a point matching matrix satisfying certain constraints needed for matching; the 1nRn and 1m×nRm×n represent vector and matrix of ones; the superscript denotes the transpose of a vector or matrix, and ||X||F2=tr(XX) is the Frobenius norm [tr(·) is the trace norm]. The α, which is newly proposed by UnionCom, is a global scaling parameter for the rescaling of the global geometrical distortions between datasets; the α1nx×ny stands for a matrix with elements all of α; and the denotes Hadamard product which is the element-wise product taken on two matrices of the same dimensions.

In the GUMA algorithm, F{0,1}nx×ny is a hard matching matrix, i.e. a 0–1 integer matrix, to mark the correspondences of cells between X and Y, where [F]ij=1 denotes that xi and yj are the counterpart of each other. Therefore, GUMA implicitly assumes that individual cells are matched in a one-to-one fashion between the two datasets, a phenomenon that is often inconsistent with real data. GUMA finds the F over the constraint set Π of all possible 0–1 integer matrices

Π={F|F{0,1}nx×ny,F1ny=1nx,F1nx1ny,nxny},

using KuhnC–Munkres algorithm. However, the set Π is neither close nor convex, leading to an NP-hard optimization problem.

UnionCom seeks a soft matching of cells between datasets. It relaxes the constraints of F to the following compact and convex set Π as

Π={F|F0,F1ny=1nx,F1nx1ny,nxny},

where F0 denotes that each element in the matrix is non-negative and that the summation of each row of F equals 1. The FΠ provides a probabilistic interpretation of sample matching between two datasets: [F]ij indicates the likelihood of xi matching with yj. Therefore, UnionCom aligns the topological structures between two datasets by solving the matrix optimization problem over the constraint set Π as follows:

minF,αL(F,α)=||α1nx×nyKxFKyF||F2,s.t.F0,α0,F1ny=1nx,F1nx1ny. (1)

We develop a prime-dual method to solve the optimization problem of Equation (1) by minimizing an augmented Lagrangian function as

Lρ(F,α,s,λ,μ)=||α1nx×nyKxFKyF||F2+μ(F1ny1nx)+λ(F1nx+s1ny)+ρΦ(F), (2)

where μ and λ are the Lagrangian multipliers; the ny dimensional non-negative vector s0 is a slack variable that transforms the inequality constraint to an equality constraint of F1nx+s=1ny; Φ(F)=12(||F1ny1nx||22+||F1nx+s1ny||22) is the penalty term added to make the solution stable and converging fast (Fig. 6c); and ρ is a user-defined hyperparameter. UnionCom is robust for the choice of ρ (Fig. 6c and d), and we set its default as ρ = 10.

The proposed prime-dual algorithm minimizes (2) over FΠ and α by the following iterative steps

Fk+1P+(FkϵFLρ(F,α,s,λ,μ)),sk+1P+(skϵ(λk+ρ(Fk+11nx+sk1ny))),μk+1μk+ϵ(Fk+11ny1nx),λk+1λk+ϵ(Fk+11nx+sk+11ny),αk+1argminαLρ(Fk+1,α,sk+1,λk+1,μk+1).

where P+ is a projection operator that maps the function into the non-negative quadrant. The ϵ is the learning rate which is often set as a small value (in generally less than 1e3). By alternating iterations on the scaling factor α and matching matrix F, UnionCom reaches an optimal solution over the relaxed convex constraint set Π. For numerical stability, we normalize KxKx/max(nx,ny) and KyKy/max(nx,ny) before applying prime-dual algorithm (see the pseudocode in Supplementary Note S1).

It is worth noting that UnionCom can be easily extended to supervised or semi-supervised alignment by fixing the corresponding elements of F to be 1 when correspondence information of cells between datasets is available.

A3. Projecting distinct unmatched features across single-cell multi-omics datasets into a common embedding space

UnionCom projects the distinct unmatched features across single-cell multi-omics datasets into a common embedding space as the coordinates for the aligned cells across datasets. To preserve both the intrinsic low-dimensional structures and the aligned cells together simultaneously, UnionCom builds upon a t-distribution stochastic neighbor embedding (t-SNE) method as in van der Maaten and Hinton (2008).

Specifically, UnionCom aims to embed the datasets XRdx×nx and YRdy×ny into a common embedded space of p-dimension (pmin{dx,dy}), with the dimensionality reduced datasets denoted as XRp×nx and YRp×ny, respectively. UnionCom finds the optimal XRp×nx and YRp×ny by minimizing a loss function J(X,Y) as follows:

minX,YJ(X,Y)=KL(PX||QX)+KL(PY||QY)+β||XYF||F2, (3)

where F is the optimal matching matrix obtained in Step A2; PX=[PijX]nx×nx and PY=[PijY]ny×ny are the cell-to-cell transition probability matrix defined in the original spaces of X and Y, respectively, as in t-SNE; and QX=[QijX]nx×nx and QY=[QijY]ny×ny, which are constrained to t-distribution, are the cell-to-cell transition probability matrix defined in the dimensionality reduced common space of X and Y, respectively, as in t-SNE; the KL-divergence is defined as KL(P||Q)=ijPijlogPijQij. The loss function J(X,Y) has three items: two KL-divergence terms between PX(PY) and QX(QY) for the two datasets, respectively, and a coupling term for measuring the distance between the matched datasets in the common embedding space. The β is a tradeoff parameter to balance the two KL terms and the coupling term. UnionCom uses the 2 norm to measure the distance of matched datasets, but other distances in the embedding space can also be used. We solve this optimization problem by the gradient descent method (see Supplementary Note S2 for more details). We set p  = 32 as defaults when the size of the features is above 100.

It is worth noting that, UnionCom is not restricted to the t-SNE-based approach for Step A3. Dimensionality reduction methods, such as elastic embedding (Chen et al., 2019) and Uniform Manifold Approximation and Projection (UMAP) (Becht et al., 2019; McInnes et al., 2018), both of which preserve local and global structures of data, can also be adopted by UnionCom for Step A3.

2.2 Data

2.2.1 Simulated data

We simulate two sets of single-cell multi-omics datasets as follows: (i) Simulation 1 contains two datasets, which share a similar complex tree with two branching points embedded in distinct 2D spaces (Fig. 2a, left panels); (ii) Simulation 2 contains two datasets: Dataset 1 has a bifurcated tree embedded in 2D space (Fig. 2b, upper left panel). To test the power of proposed global scaling factor α, the second dataset is non-linearly distorted and embedded in a 3D space, which is different from Dataset 1. Besides, a unique branch, which has different statistics from other branches, is added to evaluate the capability of UnionCom to identify unique cell type. Therefore, Dataset 2 has a trifurcated tree embedded in 3D space with one branch as the dataset-specific cell type (Fig. 2b, lower left panel; the green branch is the dataset-specific cell type).

Fig. 2.

Fig. 2.

Alignment of simulated datasets. (a) Simulation 1 and (b) Simulation 2: Visualizations of Dataset 1 (upper left panel) and Dataset 2 (lower left panel), separately using t-SNE before alignment; branches with points in the same colors are matched between datasets; visualization of the common embedding space of the two aligned datasets by MMD-MA (upper middle panel: points are colored according to their corresponding datasets; lower middle panel: points are colored according to their corresponding branches) and UnionCom (upper right panel: points are colored according to their corresponding datasets; lower right panel: points are colored according to their corresponding branches). The green branch of Dataset 2 of Simulation 2 (lower left panel of (b)) is a dataset-specific cell type, which has unique topological structure with branches of Dataset 2. (c) Averaged percentage of Neighborhood Overlap at different size of neighborhood (left panel: Simulation 1; right panel: Simulation 2)

The correspondence information of cells between the two datasets within the same simulation is known from simulation. We project the two simulated datasets into high-dimensional feature spaces (with dimensionality of 1000 for Dataset 1 and 500 for Dataset 2, respectively, for each simulation) by adding the feature vectors with elements being sampled randomly from Gaussian distribution.

2.2.2 Real single-cell multi-omics datasets

We use two real sets of single-cell multi-omics of single-cell analysis of genotype, expression and methylation (sc-GEM) data (Cheow et al., 2016) and single-cell nucleosome, methylation and transcription (sc-NMT) data (Clark et al., 2018). The first real set generated by sc-GEM sequencing, hereinafter denoted as sc-GEM data, contains two single-cell omics datasets of gene expression and DNA methylation on samples from human cells undergoing reprogramming to induced pluripotent stem (iPS) cells. The data were generated by (Cheow et al., 2016) and used in MATCHER (Welch et al., 2017). The second real dataset generated by sc-NMT sequencing, hereinafter denoted as sc-NMT data, contains three single-cell omics datasets of gene expression, DNA methylation and chromatin accessibility on samples from mouse gastrulation collected at three-time stages [embryonic day 5.5 (E5.5), E6.5 and E7.5]. The data were generated by Clark et al. (2018).

The sc-GEM sequencing measured the gene expression and DNA methylation of the same cell simultaneously; and the sc-NMT sequencing measured the gene expression, DNA methylation and chromatin accessibility of the same cell–cell simultaneously. Thus, for each of the real datasets, the cell correspondence information across single-cell multi-omics datasets is available.

2.3 Method evaluations

We evaluate the single-cell multi-omics integration methods using two indexes, (i) Neighborhood Overlap and (ii) Label Transfer Accuracy, to measure the alignment accuracies. Both indexes work on the basis of the common embedded space (coordinate) of the integrated datasets.

When the cell–cell correspondence information between multi-omics datasets is available, the Neighborhood Overlap, which was proposed by Harmonic (Stanley et al., 2018), is used to measure the ability to recover the one-to-one correspondence of cells between two datasets: for a given size of neighborhood of each cell in the common embedded space, the percentage of neighborhood overlap of a dataset is defined as the percentage of cells that can find their correspondence cells from the other dataset in their neighborhood, respectively. We use the averaged percentage of neighborhood overlap of the two datasets. The averaged percentage of neighborhood overlap ranges from 0% to 100%, and a higher percentage is indicative of a better recovery of cell-to-cell relationship between two datasets.

When the cell label information (e.g. cell types, branches of cell trajectories) is available, Label Transfer Accuracy, which has been widely used in the transfer learning community and was adopted by scAlign (Johansen and Quon, 2019), is used to measure the ability of transferring labels of cells from one dataset to another in the common embedded space. Assuming that Dataset 2 has more cells than Dataset 1, we use Dataset 2 as the training set and Dataset 1 as the testing set. We construct a kacc-nn classifier trained by cells with their labels using Dataset 2, and Label Transfer Accuracy is the prediction accuracy of the cell labels on the testing set, i.e., Dataset 1. The value of Label Transfer Accuracy, which is the percentage of cells with correctly predicted labels among all predicted cells, ranges from 0% to 100%, and a higher percentage is indicative of a better performance in transferred labels based on the two aligned datasets. We set kacc=5 as default, but the Label Transfer Accuracy is stable across different choices of kacc (Fig. 4g).

Fig. 4.

Fig. 4.

Alignment of sc-GEM omics datasets of gene expression and DNA methylation. (a) Visualizations of the gene expression and DNA methylation datasets separately using t-SNE before alignment. Visualizations of the common embedding space of the two aligned datasets by Seurat (b), MMD-MA (c), Harmony (d) and UnionCom (e), respectively [left panel: points (cells) are colored according to their corresponding datasets; right panel: points (cells) are colored according to their corresponding cell types]. (e) Averaged percentage of Neighborhood Overlap at different size of neighborhood. (f) Label Transfer Accuracy at different kacc of the kacc-nn classifier

3 Results

3.1 UnionCom outperforms the state-of-the-art methods on integrating simulated datasets with highest accuracies

We simulate two sets of single-cell multi-omics datasets. Each simulated set has similar complex topological structures, but with different geometrical distortions embedded in distinct high-dimensional spaces (Section 2.2).

We apply UnionCom for the alignment of the simulated datasets. We project the common space of the two aligned datasets by UnionCom to a 2D space for visualization using t-SNE. For each of the simulations, UnionCom integrates the two datasets with well-aligned geometrical structures (see upper right panels of Fig. 2a and b) and well-matched branches (see lower right panels of Fig. 2a and b). Although Dataset 2 of Simulation 2 has a dataset-specific branch (see the branch with green-colored points shown in the lower left panel of Fig. 2b), UnionCom still shows its accuracy in aligning the two datasets accordingly, leaving the dataset-specific branch unaligned to any other branches (see the lower right panel of Fig. 2b). In addition, we also test the cases when the dimensionality of feature space is smaller than number of samples (cells) on Simulations 1 and 2, UnionCom still aligns embedding structures quite well (Supplementary Fig. S1).

For our comparisons, we also apply the MMD-MA algorithm, which adopts a MMD term to reduce distribution discrepancy in feature spaces and to align the simulated datasets using its defaulting parameters. Although MMD-MA can align the two datasets relatively well in Simulation 1 (Fig. 2a, upper middle panel), it fails to merge samples from the two datasets of Simulation 2 into common regions (Fig. 2b, upper middle panel). We also compare with Seurat, scAlign and Harmony, and show their results of alignments in Supplementary Figure S2.

We further evaluate the accuracy of the aligned datasets using indexes of both Neighborhood Overlap and Label Transfer Accuracy (Section 2.3) and compare the performances of UnionCom with that of the state-of-the-art methods MNN, Seurat v3, scAlign, Harmony and MMD-MA (see Supplementary Note S3 for the details of the parameter settings of the compared methods). In addition, to validate the effectiveness of using geodesic distance and global scaling factor α, we also test UnionCom using Euclidean distance instead of geodesic distance (denoted as UnionCom1), as well as UnionCom with a fixed α=dy/dx (denoted as UnionCom2) for our comparisons. We do not include Liger because it needs datasets with pre-matched common feature space. We do not include MAGAN and Harmonic in our comparisons because both need correspondence information, either among samples or among features between datasets.

Among the eight methods tested, UnionCom always has the highest accuracy in both Neighborhood Overlap and Label Transfer Accuracy on the two simulated datasets (Figs 2c and 3). UnionCom1, which uses Euclidean distance, achieves almost the same accuracy as that of UnionCom in Simulation 1, but dramatically drops in accuracy on Simulation 2 in which the embedded manifolds are non-linearly distorted. UnionCom2 does not incorporate the global scaling parameter α, but it still ranks both third highest in accuracy for Simulations 1 and 2, respectively. Harmony ranks second highest accuracy on Simulation 2 but drops in accuracy on Simulation 1. MMD-MA has moderate accuracy performance on both Simulations 1 and 2 (Figs 2c and 3). It is also not surprising that MMN, scAlign and Seurat v3 do not achieve high accuracy since both were mainly developed for integrating scRNA-seq datasets of one modality.

Fig. 3.

Fig. 3.

The Label Transfer Accuracy (%) by 8 methods on the 2 simulation studies. UnionCom1: UnionCom using Euclidean distance instead of geodesic distance; UnionCom2: UnionCom with a fixed α=dy/dx

Finally, we further compare UnionCom with MMD-MA on the three simulated datasets generated by MMD-MA (Liu et al., 2019). UnionCom outperforms MMD-MA in aligning these datasets (Supplementary Note S4 and Figs S3–S6).

3.2 UnionCom accurately integrates sc-GEM omics datasets across two modalities

We apply UnionCom to integrate sc-GEM omics datasets of gene expression and DNA methylation (see Section 2.2 for details). We include Seurat v3 (which has a CCA step, to find a common feature space across datasets), Harmony (which embeds cells into a shared PCA space) and MMD-MA, for our comparisons. We obtain the processed sc-GEM data from MATCHER (Welch et al., 2017), which contain 177 cells with 34 features in the gene expression dataset and 177 cells with 27 features in the DNA methylation dataset. The cell-type annotation is from Cheow et al. (2016).

We visualize the gene expression dataset and the DNA methylation dataset separately using t-SNE with cells being colored by their annotated cell types before alignment (Fig. 4a). Both datasets demonstrate similar linear structures with the same orders on cell types: the BJ (human foreskin fibroblast) cells (red points) locate at one end, and the iPS cells (yellow points) locate at the other end of the linear trajectories. This is consistent with the underlying processes of cells undergoing reprogramming to iPS cells.

Since sc-GEM data have relatively small feature sizes, we embed the two datasets in a common space using UnionCom with dimensionality of p =2 and visualize them on the 2D UnionCom space (Fig. 4e). We find that UnionCom aligns the cells between the two datasets quite well by locating samples between datasets on a common region with similar distributions (Fig. 4e, left panel). In contrast, Seurat v3 locates cells from the gene expression dataset in an interior region surrounded by cells from the DNA methylation dataset outside (Fig. 4b, left panel); and Harmony has similar situation as that for Seurat (Fig. 4d, left panel). MMD-MA does not put the cells between two datasets on comparable scales, because the cells from the gene expression dataset are all collapsed together (Fig. 4c, left panel). When looking at the cell-type labels, we find that UnionCom (Fig. 4e, right panel) has the best separation of cell types as well as preservation of the global structures of cell lineage on the merged datasets compared with Seurat v3 (Fig. 4b, right panel) and MMD-MA (Fig. 4c, right panel). We further include MATCHER, which aligns 1D manifold and embeds data to 1D space, for comparing alignment accuracies. It is shown that UnionCom, MATCHER and Harmony achieve similar highest accuracy in Neighborhood overlap (Fig. 4f), whereas UnionCom and MATCHER achieve similar highest Label Transfer Accuracy (Fig. 4g).

The common embedding coordinates by UnionCom (Fig. 4e) can be used to reveal gene expression and/or DNA methylation patterns. When plotting the gene expression and/or DNA methylation values of the genes related to the biological process of human cells undergoing reprogramming to iPS cells (Cheow et al., 2016), we find that cells with highly expressed genes and/or highly methylated DNA are always close together on the common coordinates by UnionCom, forming into tight clusters (Supplementary Fig. S7).

3.3 Unioncom accurately integrates sc-NMT omics datasets across three modalities

We obtain the sc-NMT data from Clark et al. (2018; see Section 2.2 for details). We filter out cells with all features being denoted as missing values (‘NA’) for each of the 3 datasets, resulting in 1940 cells with 5000 features in the gene expression dataset, 709 cells with 2500 features in the DNA methylation dataset, and 612 cells with 2500 features in the chromatin accessibility dataset, respectively. We find that UMAP (Becht et al., 2019; McInnes et al., 2018) can obtain a best preservation of the global structure of cell lineage for the sc-NMT data than PCA and t-SNE (Fig. 5a). Therefore, we apply UMAP to conduct the dimensionality reduction of each of the 3 datasets to a dimensionality of 300, respectively, prior to the alignment using UnionCom, Seurat v3, MMD-MA and Harmony.

Fig. 5.

Fig. 5.

Alignment of sc-NMT omics datasets of gene expression, DNA methylation, and chromatin accessibility. (a) Visualizations of the gene expression, DNA methylation and chromatin accessibility datasets separately using UMAP before alignment. (b) Visualizations of the common embedding space of the two aligned datasets of DNA methylation and chromatin accessibility by Seurat (left panel), MMD-MA (middle panel) and Harmony (right panel), respectively; (c) Visualizations of the common embedding space of two aligned datasets of DNA methylation and chromatin accessibility (left panel) and three aligned datasets of DNA methylation, chromatin accessibility and gene expression by UnionCom (right panel). Upper panel of (b and c): points (cells) are colored according to their corresponding datasets; Lower panel of (b and c): points (cells) are colored according to their corresponding time stages. (d) Averaged percentage of Neighborhood Overlap (upper panel) and Label Transfer Accuracy (lower panel) on the alignment of the two datasets of DNA methylation and chromatin accessibility

We visualize the three datasets of gene expression, DNA methylation and chromatin accessibility separately using UMAP with cells being colored by their annotated time stage (e.g. E5.5, E6.5 and E7.5; Fig. 5a). All three datasets demonstrate similar dominant linear structures of cell lineage, consistent with the underlying processes of cell development during mouse gastrulation from E5.5 to E7.5.

We apply UnionCom to integrate sc-NMT omics datasets of gene expression, DNA methylation and chromatin accessibility simultaneously, and embed them into a common space (Fig. 5c). For multiple datasets, UnionCom selects the dataset with largest sample size as the reference dataset, and aligns the other datasets with respect to the reference. When visualizing the common embedded space of the three datasets by UnionCom using UMAP in 2D space, we find that UnionCom integrates the three datasets across modalities quite well by aligning cells across datasets along a dominant linear trajectory on similar regions (Fig. 5c, upper right panel), and also by preserving the global structure of time stage orders (Fig. 5c, lower right panel).

In addition, we include Seurat v3, MMD-MA and Harmony as our comparisons and demonstrate their performances on the alignment of the two datasets of DNA methylation and chromatin accessibility. UnionCom still achieves highest accuracy in both Neighborhood Overlap (Fig. 5d, upper panel) and Label Transfer Accuracy when using time stages as cell labels (Fig. 5d, lower panel). We find that UnionCom aligns the cells between the two datasets quite well in 2D space by aligning the cells between the datasets along a linear trajectory and by merging the two datasets on a common region with similar distributions (Fig. 5c, upper right panel); when looking at the cell labels of time stages, we find that UnionCom preserves the global structures of time stage orders (Fig. 5c, lower right panel). In contrast, both Seurat v3 (Fig. 5b, left panel) and MMD-MA (Fig. 5b, middle panel) do not merge the cells between two datasets into comparable spaces.

3.4 Robustness analysis of UnionCom

We confirm the robustness of UnionCom in both subsampling features of data and parameter choices on the two sc-NMT datasets for DNA methylation and chromatin accessibility. When randomly sampling a subset of features without replacement from both DNA accessibility and chromatin methylation datasets separately prior to data alignment, the label transfer accuracies by UnionCom are stable, showing much smaller fluctuation than those by Seurat, MMD-MA and Harmony (Fig. 6a). When choosing k of the k-nn graph in Step A1 of UnionCom from 4 to 10, the label transfer accuracies of UnionCom are stable around 80% (Fig. 6b). When choosing different hyperparameter ρ for the penalty term Φ(F) in Equation (2), the training loss of the prime-dual algorithm converges very fast to the same value when ρ ranges from 5 to 20; however, when ρ  =  0 which means no penalty term is applied, the loss shows a strong oscillation pattern and convergences slowly (Fig. 6c). Besides, when ρ  =  0, the label transfer accuracy decreases significantly to about 40% with the same training epoch and rate, indicating the necessity of adding the penalty term (Fig. 6d). When tradeoff parameter β in Equation (3) ranges from 1 to 50, the label transfer accuracies of UnionCom are changing slowly (Fig. 6e). Finally, when embedding the two dataset into a common space of different dimensionality of p in Step A3 of UnionCom from 10 to 100, the label transfer accuracies of UnionCom are stable with small fluctuation (Fig. 6f).

4 Discussion

Manifold alignment is one of the foremost research fields of machine-learning and data science (Cui et al., 2012, 2014; Ham et al., 2005; Liu et al., 2019; Pei et al., 2012; Wang and Mahadevan, 2008, 2009, 2011). In this study, we develop UnionCom, the unsupervised topological alignment method for single-cell multi-omics data integration. UnionCom represents the intrinsic topological structures embedded in data as distance matrices and then formulates the alignment problem into a convex problem of soft matching of matrices.

UnionCom has the three advantages. First, it is totally unsupervised and data-driven: it does not need the correspondence information, either among cells or among features. UnionCom not only achieves high accuracy in the integration of single-cell multi-omics datasets, but also has high accuracy when applying to the batch correction of scRNA-seq datasets with matched features (see Supplementary Note S5 and Fig. S8). Second, it is a non-linear method, which characterizes the non-linear intrinsic structures of the data based on using the geometrical distance matrices for alignment and a t-SNE-like method for finding common embedding space. Therefore, UnionCom achieves best performance on matching non-linear topological structures comparing with linear batch correction methods (e.g. Seurat, MNN and Harmony). Third, UnionCom not only matches similar structures between datasets, but also can accommodate samples with dataset-specific cell types, since UnionCom utilizes both local and global topological information of data. On the other hand, the non-linear MMD-based methods (e.g. MMD-MA), which can be regarded as ‘matching of infinite-order moments’, will always transform the matched datasets into the same distribution and thus cannot handle data-specific structures.

Different from methods, such as Seurat and scAlign, which conduct the dimensionality reduction prior to the alignment of the cells, UnionCom first aligns the cells across datasets based on the geometrical distance of metric space and then projects the distinct features into a common low-dimensional embedded space. We thus propose a global scaling factor α to account for the global geometrical distortions on the embedded intrinsic topological structures and remove the need for pre-matching and normalizing distinct features across multi-omics datasets. Since the un-matched features across datasets have different distributions with complex intercorrelations, normalization of features across single-cell multi-omics datasets to the same distribution can further distort the intrinsic geometric structures, making the alignment problem more difficult. For complex embedded hierarchical structures with multi-scales, UnionCom can align the manifold recursively by introducing scaling-specific factors for each scale of the manifold, and we plan to pursue this topic in our future work.

UnionCom has the following potential limitations. First, UnionCom may be inadequate to align the embedded structures with certain symmetries, since distance matrices will be invariant when switching symmetric parts of the embedded structure. It will be potential limitation for the unsupervised matching methods, since the geometry information itself cannot distinct the symmetric parts. However, it is not a big issue for single-cell data analysis, since single cells are highly heterogeneous with non-uniform distributions. We can see clearly that UnionCom aligns the linear structures quite well on both sc-GEM and sc-NMT datasets. Second, UnionCom is not scalable to large-scale datasets with cells up to ∼106, which can be handled by Harmony on a personal computer. Although slower than the batch correction methods such as Seurat, MNN and Harmony, UnionCom is computationally efficient with computing time <50 s on the datasets utilized in our study on a personal computer, showing comparable computational speed as MMD-MA (see Supplementary Table S1). As the demanding computation and memory storage of distance matrices raised by large-scale single-cell data, we plan to pursue high performance computing and memory efficiency simultaneously in our future work.

Funding

The work is supported by NSFC grants [Numbers 11571349, 91630314 and 61733018], NCMIS of CAS, LSC of CAS and the Youth Innovation Promotion Association of CAS.

Conflict of Interest: none declared.

Supplementary Material

btaa443_Supplementary_Data

References

  1. Amodio M., Krishnaswamy S. (2018) MAGAN: aligning biological manifolds. In: Proceedings of the 35th International Conference on Machine Learning, pp. 215–223. ACM, Stockholm, Sweden.
  2. Becht E. et al. (2019) Dimensionality reduction for visualizing single-cell data using UMAP. Nat. Biotechnol., 37, 38–44. [DOI] [PubMed] [Google Scholar]
  3. Chen Z. et al. (2019) DensityPath: an algorithm to visualize and reconstruct cell state-transition path on density landscape for single-cell RNA sequencing data. Bioinformatics, 35, 2593–2601. [DOI] [PubMed] [Google Scholar]
  4. Cheow L.F. et al. (2016) Single-cell multimodal profiling reveals cellular epigenetic heterogeneity. Nat. Methods, 13, 833–836. [DOI] [PubMed] [Google Scholar]
  5. Clark S.J. et al. (2018) scNMT-seq enables joint profiling of chromatin accessibility DNA methylation and transcription in single cells. Nat. Commun., 9, 781. [DOI] [PMC free article] [PubMed] [Google Scholar]
  6. Cui Z. et al. (2012) Image sets alignment for video-based face recognition. In: 2012 IEEE Conference on Computer Vision and Pattern Recognition, pp. 2626–2633. IEEE, Providence, Rhode Island, USA.
  7. Cui Z. et al. (2014) Generalized unsupervised manifold alignment. In: Advances in Neural Information Processing Systems 27, pp. 2429–2437. MIT Press, Montreal, Canada.
  8. Efremova M., Teichmann S.A. (2020) Computational methods for single-cell omics across modalities. Nat. Methods, 17, 14–17. [DOI] [PubMed] [Google Scholar]
  9. Haghverdi L. et al. (2018) Batch effects in single-cell RNA-sequencing data are corrected by matching mutual nearest neighbors. Nat. Biotechnol., 36, 421–427. [DOI] [PMC free article] [PubMed] [Google Scholar]
  10. Ham J. et al. (2005) Semisupervised alignment of manifolds. In: Proceedings of the Tenth International Workshop on Artificial Intelligence and Statistics, pp. 120–27. Bridgetown, Barbados.
  11. Hie B. et al. (2019) Efficient integration of heterogeneous single-cell transcriptomes using Scanorama. Nat. Biotechnol., 37, 685–691. [DOI] [PMC free article] [PubMed] [Google Scholar]
  12. Johansen N., Quon G. (2019) scAlign: a tool for alignment, integration, and rare cell identification from scRNA-seq data. Genome Biol., 20, 166. [DOI] [PMC free article] [PubMed] [Google Scholar]
  13. Korsunsky I. et al. (2019) Fast, sensitive and accurate integration of single-cell data with Harmony. Nat. Methods, 16, 1289–1296. [DOI] [PMC free article] [PubMed] [Google Scholar]
  14. Liu J. et al. (2019) Jointly embedding multiple single-cell omics measurements. In: 19th International Workshop on Algorithms in Bioinformatics (WABI 2019), pp. 10:1–10:13. [DOI] [PMC free article] [PubMed] [Google Scholar]
  15. McInnes L. et al. (2018) UMAP: Uniform manifold approximation and projection for dimension reduction. arXiv: 1802.03426v2.
  16. Pei Y. et al. (2012) Unsupervised image matching based on manifold alignment. IEEE Trans. Pattern Anal. Mach. Intell., 34, 1658–1664. [DOI] [PubMed] [Google Scholar]
  17. Stanley J.S., III et al. (2019) Manifold alignment with feature correspondence. arXiv: 1810.00386v3.
  18. Stuart T., Satija R. (2019) Integrative single-cell analysis. Nat. Rev. Genet., 20, 257–272. [DOI] [PubMed] [Google Scholar]
  19. Stuart T. et al. (2019) Comprehensive integration of single-cell data. Cell, 177, 1888–1902.e21. [DOI] [PMC free article] [PubMed] [Google Scholar]
  20. Tanay A., Regev A. (2017) Scaling single-cell genomics from phenomenology to mechanism. Nature, 541, 331–338. [DOI] [PMC free article] [PubMed] [Google Scholar]
  21. Tenenbaum J.B. et al. (2000) A global geometric framework for nonlinear dimensionality reduction. Science, 290, 2319–2323. [DOI] [PubMed] [Google Scholar]
  22. van der Maaten L., Hinton G. (2008) Visualizing data using t-SNE. J. Mach. Learn. Res., 9, 2579–2605. [Google Scholar]
  23. Wang C., Mahadevan S. (2008) Manifold alignment using procrustes analysis. In: Proceedings of the 25th International Conference on Machine Learning, pp. 1120–1127. ACM, Helsinki, Finland.
  24. Wang C., Mahadevan S. (2009) Manifold alignment without correspondence. In: Twenty-First International Joint Conference on Artificial Intelligence. Morgan Kaufmann, Pasadena, California, USA.
  25. Wang C., Mahadevan S. (2011) Heterogeneous domain adaptation using manifold alignment. In: Twenty-Second International Joint Conference on Artificial Intelligence, pp. 1541–1546. Morgan Kaufmann, Barcelona, Spain.
  26. Welch J.D. et al. (2017) MATCHER: manifold alignment reveals correspondence between single cell transcriptome and epigenome dynamics. Genome Biol., 18, 138. [DOI] [PMC free article] [PubMed] [Google Scholar]
  27. Welch J.D. et al. (2019) Single-cell multi-omic integration compares and contrasts features of brain cell identity . Cell, 177, 1873–1887.e17. [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

btaa443_Supplementary_Data

Articles from Bioinformatics are provided here courtesy of Oxford University Press

RESOURCES