Next Article in Journal
Breeding Tomato Hybrids for Flavour: Comparison of GWAS Results Obtained on Lines and F1 Hybrids
Next Article in Special Issue
Improved Large-Scale Homology Search by Two-Step Seed Search Using Multiple Reduced Amino Acid Alphabets
Previous Article in Journal
Genetic Variation in PADI6-PADI4 on 1p36.13 Is Associated with Common Forms of Human Generalized Epilepsy
Previous Article in Special Issue
EPIsHilbert: Prediction of Enhancer-Promoter Interactions via Hilbert Curve Encoding and Transfer Learning
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Tensor-Decomposition-Based Unsupervised Feature Extraction in Single-Cell Multiomics Data Analysis

1
Department of Physics, Chuo University, Tokyo 112-8551, Japan
2
Department of Computer Science, King Abdulaziz University, Jeddah 21589, Saudi Arabia
*
Author to whom correspondence should be addressed.
Submission received: 25 August 2021 / Revised: 13 September 2021 / Accepted: 15 September 2021 / Published: 18 September 2021

Abstract

:
Analysis of single-cell multiomics datasets is a novel topic and is considerably challenging because such datasets contain a large number of features with numerous missing values. In this study, we implemented a recently proposed tensor-decomposition (TD)-based unsupervised feature extraction (FE) technique to address this difficult problem. The technique can successfully integrate single-cell multiomics data composed of gene expression, DNA methylation, and accessibility. Although the last two have large dimensions, as many as ten million, containing only a few percentage of nonzero values, TD-based unsupervised FE can integrate three omics datasets without filling in missing values. Together with UMAP, which is used frequently when embedding single-cell measurements into two-dimensional space, TD-based unsupervised FE can produce two-dimensional embedding coincident with classification when integrating single-cell omics datasets. Genes selected based on TD-based unsupervised FE are also significantly related to reasonable biological roles.

1. Introduction

Single-cell multiomics data analysis is challenging [1]. There are multiple reasons for this issue. First, it inevitably includes too many missing values. In the usual high-throughput sequencing (HTS), the so-called depth can compensate for this problem. Nevertheless, because of the very limited amount of RNA retrieved from individual cells available, “depth” cannot resolve this missing value problem. Second, too many missing values result in apparent diversity. The primary purpose of single-cell analysis is to identify the diversity of individual cells that cannot be recognized by the tissue-level HTS. Although missing values are random, apparently very variant profiles appear from a single profile, which can be recognized if there is a large enough number of reads available. This compels researchers to distinguish between true biological diversity and apparent diversity caused by missing values [2].
Finally, single-cell analysis is computationally challenging. Because there are not many samples in the standard HTS, even if the number of features is large, the overall required computational resources decided by the product between the number of features and the number of samples are very limited. Nonetheless, since the number of samples that is the same as that of cells can be huge in single-cell analysis, single-cell analysis can be computationally very challenging.
To resolve these difficulties, we employed tensor-decomposition (TD)-based unsupervised feature extraction (FE) [3]. Prior to applying TD to multiomics datasets, singular-value decomposition (SVD) was applied to individual omics profiles such that individual omics profiles have common L singular-value vectors. Then, K omics profiles are formatted as an L × M × K -dimensional tensor, where M is the number of single cells. Then, higher-order singular-value decomposition (HOSVD), which is a type of TD, is applied to the tensor. UMAP applied to singular-value vectors attributed to single cells by HOSVD successfully generated two-dimensional embedding, coincident with the known classification of single cells.

2. Materials and Methods

2.1. Gene Expression Profiles

Two single-cell multiomics datasets were downloaded from GEO using the following two GEO IDs.

2.1.1. GSE154762: Dataset 1

The multiomics dataset [4] retrieved from GEO ID GSE154762, which is denoted as Dataset 1 in this study, is composed of 899 single cells for which gene expression, DNA methylation, and DNA accessibility were measured. These single cells represent human oocyte maturation (Table 1). For gene expression, the file “GSE154762_hO_scChaRM_count _matix.txt.gz” was downloaded from the supplementary file of GEO and was loaded into R [5] using the read.table function in R. For DNA methylation and DNA accessibility, 899 files with the extensions “WCG.bw” and “GCH.bw” were downloaded from the supplementary files of GEO and were loaded into R using the import function in the rtracklayer [6] package in R.

2.1.2. GSE121708: Dataset 2

The multiomics dataset [7] retrieved from GEO ID GSE154762, which is denoted as Dataset 2 in this study, is composed of 852 single cells for which DNA methylation and DNA accessibility were measured, as well as 758 single cells for which gene expression was measured. These single cells represent the four time points of the mouse embryo (Table 2). For gene expression, the file “GSE121650_rna_counts.tsv.gz” was downloaded from the supplementary file of GEO and was loaded into R using the read.table function in R. For DNA methylation and DNA accessibility, 852 files with the extensions “met.tsv.gz” and “acc.tsv.gz” were downloaded from the supplementary file of GEO and were loaded into R using the read.table function in R.

2.2. Preprocessing of DNA Methylation Profiles

First, we collected genomic positions for which at least one measurement was performed for at least one single cell (i.e., union). Then, for each genomic position, three integers, −1, 0, and 1, were assigned. When the genomic position was measured in a single cell and its state was methylated (nonmethylated), we attributed 1 (−1) to the genomic position of the single cell. Otherwise (i.e., missing observation), we attributed 0 to the genomic transition in a single cell. x i j 2 R N 2 × M was stored as a sparse matrix object using the Matrix [8] package in R because of the large N 2 .

2.3. Preprocessing of DNA Accessibility

First, we divided the whole genome into 200 nucleotide regions, and DNA accessibility was summed up within individual regions. These values, which show the summation of DNA accessibility within individual regions, are regarded as DNA accessibility at the individual 200 nucleotide regions, each of which is supposed to approximately correspond to a single nucleosome that is composed of 140-length DNA that wraps around histones and 80-length linker DNA. In this study, these 200 nucleotide regions are called “nucleosome regions”. x i j 3 R N 3 × M was stored as a sparse matrix object using the Matrix package in R because of the large N 3 .

2.4. TD-Based Unsupervised FE

2.4.1. Reduction of Feature Dimensions

Here, feature denotes gene expression, DNA methylation, or DNA accessibility. Because the features of these three datasets differ from one another, we first applied SVD to these features. Suppose x i j k R N k × M × K represents the value of the ith feature (expression of the ith gene, methylation of the ith genomic location, or DNA accessibility of the ith nucleosome region) at the kth single cell of the kth omics data ( 1 k K = 3 , k = 1 : gene expression, k = 2 : DNA methylation, and k = 3 : DNA accessibility). Applying SVD to x i j k , we obtain:
x i j k = = 1 L λ u i k v j k
where λ is the th singular value and u i k and v j k are the ith and jth components of the th left and right singular-value vectors, respectively. Then, x i j k is transformed to x j k R L × M × K to have the same (common) feature dimension, L, independent of k, as:
x j k = i = 1 N k u i k x i j k

2.4.2. Data Normalization

Prior to applying SVD to the individual omics profiles in these two datasets, x i j k , ( k = 2 , 3 ) , that is DNA methylation and accessibility, of Dataset 1 was normalized such that:
i = 1 N k | x i j k | = N k
whereas x i j 1 , i.e., gene expression, was normalized such that:
i = 1 N K x i j 1 = 0
i = 1 N k x i j 1 2 = N k
for Datasets 1 and 2. The reason why DNA methylation and the accessibility of Dataset 2 were not normalized is because i | x i j k | , ( k = 2 , 3 ) is very small in some single cells in Dataset 2. Thus, applying normalization adds significant weight to these single cells with fewer observations and drastically skewed outcomes. To avoid this problem, x i j k , ( k = 2 , 3 ) of Dataset 2 was not normalized.

2.4.3. TD Applied to Dimension-Reduced Multiomics Datasets

HOSVD [3] was applied to the tensor, x j k , and we obtained:
x j k = 1 = 1 L 2 = 1 M 3 = 1 K G ( 1 2 3 ) u 1 u 2 j u 3 k
where G R L × M × K is the core tensor that represents the contribution of u 1 u 2 j u 3 k to x j k . u 1 R L × L , u 2 j R M × M , u 3 k R K × K are singular-value matrices and are orthogonal matrices.

2.5. Categorical Regression

For categorical regression to test the coincidence between classification shown in Table 1 or Table 2 and singular-value vectors attributed to the jth single cells, we performed categorical regression:
v j k = a k s δ j s + b k
u 2 j = a 2 s δ j s + b 2
where s denotes one of the classifications shown in Table 1 or Table 2, a k s , b k , a 2 s , b 2 are regression coefficients, and δ j s takes the value of 1 when the jth single cell belongs to the sth classification and 0 otherwise. Categorical regression was performed using the ls function in R. The obtained p-values were corrected using the Benjamini-Hochberg (BH) criterion [3]. s or 2 s associated with adjusted p-values less than 0.01 were regarded to be coincident with classification.

2.6. UMAP

Two-dimensional embedding was performed by UMAP [9]. The umap function implemented in R was used.

2.7. Gene Selection

After identifying which u 2 j coincided with the classification, we needed to identify which u 1 was associated with the selected u 2 j by investigating | G ( 1 2 3 ) | ; 1 s with a larger | G | with the selected 2 were regarded to be coincident with the classification. Then, the selected u 1 was converted back to u 1 i 1 attributed to genes as:
u 1 i = = 1 L u 1 u i 1
p-values can be attributed to genes, i, assuming u 1 i obeys a multiple Gaussian distribution (null hypothesis) as:
P i = P χ 2 > 1 u 1 i σ 1 2
where the summation is taken over only the selected 1 s, P χ 2 [ > x ] is the cumulative χ 2 distribution, where the argument is larger than x, and σ 1 is the standard deviation. P i s were corrected by the BH criterion [3], and is associated with adjusted P i less than 0.01 were selected.

3. Results

3.1. Dataset 1

We obtained x i j 1 R 26500 × 899 , x i j 2 R 26438807 × 899 , and x i j 3 R 15478375 × 899 . SVD was applied to x i j k with L = 10 , as in Equation (1). For x i j k , k = 2 , 3 , SVD was performed using the irlba function in the irlba package [10] in R because of the large N k , k = 2 , 3 , as many as ten million. Then, HOSVD was applied to x j k , as in Equation (2).
One possible validation to check whether the above procedure works properly is to check whether v j k and u 2 j are coincident with the classification shown in Table 1. Because the above procedure is fully unsupervised, it is unlikely that v j k and u 2 j are accidentally coincident with the classification. To quantitatively validate the coincidence between the classification and v j k or u 2 j , we applied categorical regression (see Section 2.5).
Table 3 shows the number of singular-value vectors coincident with the classification shown in Table 1. When SVD was applied to individual omics data, because L = 10 , the number of singular-value vectors was 10 as well. When K omics datasets were integrated and HOSVD was applied, the number of singular-value vectors was K L = 10 K . Thus, when DNA methylation and accessibility were integrated, 20 singular-value vectors were available. When all three omics data were integrated, 30 singular-value vectors were available. It is obvious that for all five cases, at least one singular-value vector was coincident with the classification. Thus, our strategy was essentially successful.
To further validate the successful integration of singular-value vectors, we applied UMAP to 20 or 30 singular-value vectors obtained by HOSVD (Figure 1).
It is obvious that the integration of all three omics datasets (lower) was more coincident with classification than that of the integration of the two omics datasets, DNA methylation, and accessibility (upper). This suggests the usefulness of integrating the three omics datasets. In fact, single omics data cannot provide two-dimensional embedding coinciding with classification (Figure S1).
We also attempted to validate biological outcomes when all three omics datasets were integrated. We selected 47 genes associated with adjusted P i less than 0.01, as described in Section 2.7 using u 1 i because u 1 i is associated with the largest:
2 3 = 1 3 G 2 ( 1 2 3 ) ,
where the summation of 2 is taken over only 18 2 s coincident with the classification (Table 3). The selected 47 genes (Data S1) were uploaded to Enrichr [11].
Forty-seven genes were enriched by H3K36me3 based on “ENCODE Histone Modifications 2015”; H3K36m3 is known to play critical roles during oocyte maturation [12]. Forty-seven genes were also targeted by MYC based on “ENCODE and ChEA Consensus TFs from ChIP-X”; Myc is known to play critical roles in oogenesis [13]. Forty-seven genes were also targeted by TAF7 based on “ENCODE and ChEA Consensus TFs from ChIP-X” and “ENCODE TF ChIP-seq 2015”; TAF7 is known to play critical roles during oocyte growth [14]. Forty-seven genes were also targeted by ATF2 based on “ENCODE and ChEA Consensus TFs from ChIP-X”; the expression of ATF2 is known to be altered during oocyte development [15]. This suggests that our strategy correctly captures regulation-related parts (full data of the enrichment analysis are available as Data S1).

3.2. Dataset 2

To confirm that the success in the previous section was not accidental, we applied the same procedure to Dataset 2 as well. We obtained x i j 1 R 22084 × 758 , x i j 2 R 20106507 × 852 , and x i j 3 R 13627678 × 852 . SVD was applied to x i j k with L = 10 , as in Equation (1). For x i j k , k = 2 , 3 , SVD was performed using the irlba function in the irlba package [10] in R because of the large N k , k = 2 , 3 of as many as ten million. Then, HOSVD was applied to x j k , as in Equation (2). Because N 1 = 758 < N 2 = N 2 = 852 , when HOSVD was applied to x j k composed of all three omics datasets, only 758 single cells shared with all x i j k were considered. As described in the previous section, we first validated the coincidence between singular-value vectors attributed to single cells (Table 4), that is v j and u 2 k , and the classification in Table 2.
The coincidence between the singular-value vectors and the classification in Table 4 was even better than that in Table 3. Thus, it is unlikely that the superior outcome in Table 3 was purely accidental. To further validate the successful integration of singular-value vectors, we applied UMAP to 20 or 30 singular-value vectors obtained by HOSVD (Figure 2).
It is obvious that the integration of all three omics datasets (lower) was more coincident with classification than that of the integration of the two omics datasets, DNA methylation, and DNA accessibility (upper), as can be seen in Figure 2. This again confirms the usefulness of integrating the three omics datasets. In fact, single omics data cannot provide two-dimensional embedding coinciding with classification (Figure S2).
We also attempted to validate biological outcomes when all three omics datasets were integrated. We selected 175 genes associated with adjusted P i less than 0.01, as described in Section 2.7 using u 1 i because u 1 i is associated with the largest:
2 3 = 1 3 G 2 ( 1 2 3 )
where the summation of 2 is taken over only 18 2 s coincident with the classification (Table 4). The selected 175 genes (Data S2) were converted to gene symbols by the DAVID [16] gene ID converter and were uploaded to Enrichr.
One-hundred and seventy-five genes were enriched by H3K36me3 based on “ENCODE Histone Modifications 2015”; H3K36m3 is known to play critical roles during gastrulation [17]. One-hundred and seventy-five genes were also targeted by MYC based on “ENCODE and ChEA Consensus TFs from ChIP-X”; Myc is also known to play critical roles in gastrulation [18]. One hundred and seventy-five genes were also targeted by TAF7 based on “ENCODE and ChEA Consensus TFs from ChIP-X” and “ENCODE TF ChIP-seq 2015”; TAF7 is known to play critical roles during gastrulation [19]. One-hundred and seventy-five genes were also targeted by ATF2 based on “ENCODE and ChEA Consensus TFs from ChIP-X”; the expression of ATF2 is known to be maintained during gastrulation [20]. This suggests that our strategy correctly captured regulation-related parts (full data of the enrichment analysis are available as Data S2).
These two examples, the application to Datasets 1 and 2, demonstrate the usefulness of the present strategy to integrate single-cell multiomics datasets composed of gene expression, DNA methylation, and accessibility.

4. Discussion

In this study, we demonstrated the usefulness of our strategy when it was applied to the integrated analysis of single-cell multiomics datasets composed of gene expression, DNA methylation, and DNA accessibility. One might wonder if other more popular methods can achieve similar performance because our strategy is useless if others can perform comparably. There are several advantages of our method, which other methods do not have.
First, we do not have to fill in the missing values with nonzero values. Single-cell measurements are usually associated with a large number of missing values (Table 5).
Although gene expression profiles were associated with a relatively small number of missing components, more than 70 % were missing. For DNA methylation and accessibility, the situation was very difficult to treat. Only a few percentages of components had values, while the rest were missing values. To address this problem, especially for DNA methylation and accessibility, heavy preprocessing is usually required. For example, for Dataset 1, statistical tests were applied and regions associated with significant p-values were selected [4], which reduced the number of features attributed to DNA methylation and accessibility. Because such a statistical test automatically filters out regions filled in with missing values, the ratio of nonzero components was also reduced as a result. For Dataset 2, the authors restricted the features to only the most variable ones (typically ∼ 10 3 ) and occasionally filled in missing components with Bayesian models [7]. These procedures inevitably introduce arbitrariness to the outcomes, as preprocessing the data might affect the outcome. In contrast to these arbitrary procedures, our method is almost unsupervised. We did not select any features or fill in the missing values. Despite these fully unsupervised strategies, our results were highly coincident with the classification (Table 3 and Table 4 and Figure 1 and Figure 2). From this perspective, our strategy is superior to the other methods.
Second, our method can deal with massive datasets. For example, although integrated analysis of multiomics data was performed using multiomics factor analysis (MOFA) [21] in the original studies [4,7] of Datasets 1 and 2, MOFA cannot accept x i j k in this study as inputs because MOFA does not implement sparse matrix architecture. During the computation of MOFA, zero values must be filled in with nonzero values to evaluate the convergence; this results in a dense matrix that cannot be stored in the computer memory because the number of components of DNA methylation and accessibility is too large to store them as they are (Table 5). In our computation, we can apply SVD to these large datasets while keeping them in a sparse matrix format using the irlba package implemented in R. SVD not only reduces the number of features to L, but also fills in missing values. Thus, we can manage a large matrix as in our implementation.
Third, our method is free from the dividing weight between multiomics datasets; how to weigh individual omics data must be decided based on some criteria outside the datasets available. Nevertheless, in our implementation, the weight of individual omics data is represented by u 3 k , which is automatically decided by simply applying HOSVD to a multiomics dataset. Thus, from this perspective, our strategy is outstanding.
Although we showed that the integration of all three omics data was superior to that of the integration of DNA methylation and accessibility (Figure 1 and Figure 2), one might wonder if the integration of gene expression and DNA methylation or DNA accessibility might be comparable to that of all thee omics datasets. In order to deny this possibility, we also considered these combinations of two of the three omics datasets (Figures S3 and S4). Although the integration of gene expression and DNA accessibility in Dataset 1 (Figure S3B) is comparable to that of all three omics data, neither integration of gene expression and DNA methylation (Figure S4A) nor that of gene expression and DNA accessibility (Figure S4B) is comparable to that of all three omics data in Dataset 2. Thus, it is obvious that only the integration of the three omics datasets can give us UMAP embedding coincident with the classification regardless of the dataset considered.
As for the comparisons with other methods, as mentioned above, no methods implemented with a sparse matrix architecture and applicable to multiomics datasets exist to our knowledge. Thus, we could not compare our performance to other methods.
Prospective uses of our methods are as follows. First of all, it can integrate gene expression profiles, DNA methylation, and accessibility in single-cell measurements without applying preprocessing; this enables researchers to obtain reasonable results without struggling to convert raw data into treatable formats. In addition to this, since it can save the memories required for analyzing single-cell multiomics datasets, more researchers who do not have massive computational facilities can analyze massive single-cell measurements.

5. Conclusions

In this study, we proposed a method for applying TD-based unsupervised FE to single-cell multiomics datasets composed of gene expression, DNA methylation, and DNA accessibility. Together with UMAP, the proposed method successfully integrated a multiomics dataset and generated a two-dimensional embedding of single cells coincident with the classification. The implementation requires neither filling missing values nor massive CPU memory to store multiomics datasets of single cells and can deal with DNA methylation and accessibility with ten million features. The present implementation is very promising and can be a de facto standard method to integrate single-cell multiomics datasets composed of gene expression, DNA methylation, and DNA accessibility.

Supplementary Materials

The following are available online at https://0-www-mdpi-com.brum.beds.ac.uk/article/10.3390/genes12091442/s1, Figure S1: UMAP embedding of single omics data for data set 1, Figure S2: UMAP embedding of single omics data for data set 2, Figure S3: UMAP embedding of integration of two omics data for data set 1, Figure S4: UMAP embedding of integration of two omics data for data set 2.

Author Contributions

Y.-h.T. planned the research and performed the analyses. Y.-h.T. and T.T. evaluated the results, discussions, and outcomes and wrote and reviewed the manuscript. All authors have read and agreed to the published version of the manuscript.

Funding

This work was supported by KAKENHI (Grant Numbers 19H05270, 20H04848, and 20K12067) to Y.-h.T.

Data Availability Statement

The data used in this study are available in GEO ID GSE154762 and GSE121708. A sample of the R source can be found at https://github.com/tagtag/scMultiR (accessed on 14 September 2021).

Conflicts of Interest

The authors declare no conflict of interest. The funders had no role in the design of the study; in the collection, analyses, or interpretation of data; in the writing of the manuscript; nor in the decision to publish the results.

Abbreviations

The following abbreviations are used in this manuscript:
BHBenjamini–Hochberg
FEfeature extraction
HOSVDhigher-order singular-value decomposition
HTShigh-throughput sequencing
MOFAMulti-Omics Factor208Analysis
SVDsingular-value decomposition
TDtensor decomposition

References

  1. Lee, J.; Hyeon, D.Y.; Hwang, D. Single-cell multiomics: Technologies and data analysis methods. Exp. Mol. Med. 2020, 52, 1428–1442. [Google Scholar] [CrossRef] [PubMed]
  2. Liu, Q.; Herring, C.A.; Sheng, Q.; Ping, J.; Simmons, A.J.; Chen, B.; Banerjee, A.; Li, W.; Gu, G.; Coffey, R.J.; et al. Quantitative assessment of cell population diversity in single-cell landscapes. PLoS Biol. 2018, 16, 1–29. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  3. Taguchi, Y.H. Unsupervised Feature Extraction Applied to Bioinformatics; Springer International Publishing: Berlin/Heidelberg, Germany, 2020. [Google Scholar] [CrossRef]
  4. Yan, R.; Gu, C.; You, D.; Huang, Z.; Qian, J.; Yang, Q.; Cheng, X.; Zhang, L.; Wang, H.; Wang, P.; et al. Decoding dynamic epigenetic landscapes in human oocytes using single-cell multi-omics sequencing. Cell Stem Cell 2021, 28, 1641–1656.e7. [Google Scholar] [CrossRef] [PubMed]
  5. R Core Team. R: A Language and Environment for Statistical Computing; R Foundation for Statistical Computing: Vienna, Austria, 2020. [Google Scholar]
  6. Lawrence, M.; Gentleman, R.; Carey, V. rtracklayer: An R package for interfacing with genome browsers. Bioinformatics 2009, 25, 1841–1842. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  7. Argelaguet, R.; Clark, S.J.; Mohammed, H.; Stapel, L.C.; Krueger, C.; Kapourani, C.A.; Imaz-Rosshandler, I.; Lohoff, T.; Xiang, Y.; Hanna, C.W.; et al. Multi-omics profiling of mouse gastrulation at single-cell resolution. Nature 2019, 576, 487–491. [Google Scholar] [CrossRef] [PubMed]
  8. Bates, D.; Maechler, M. Matrix: Sparse and Dense Matrix Classes and Methods; R Package Version 1.3-4; R Package: Boston, MA, USA, 2021. [Google Scholar]
  9. Becht, E.; McInnes, L.; Healy, J.; Dutertre, C.A.; Kwok, I.W.H.; Ng, L.G.; Ginhoux, F.; Newell, E.W. Dimensionality reduction for visualizing single-cell data using UMAP. Nat. Biotechnol. 2018, 37, 38–44. [Google Scholar] [CrossRef] [PubMed]
  10. Baglama, J.; Reichel, L.; Lewis, B.W. irlba: Fast Truncated Singular Value Decomposition and Principal Components Analysis for Large Dense and Sparse Matrices; R Package Version 2.3.3; R Package: Boston, MA, USA, 2019. [Google Scholar]
  11. Kuleshov, M.V.; Jones, M.R.; Rouillard, A.D.; Fernandez, N.F.; Duan, Q.; Wang, Z.; Koplev, S.; Jenkins, S.L.; Jagodnik, K.M.; Lachmann, A.; et al. Enrichr: A comprehensive gene set enrichment analysis web server 2016 update. Nucleic Acids Res. 2016, 44, W90–W97. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  12. Xu, Q.; Xiang, Y.; Wang, Q.; Wang, L.; Brind’Amour, J.; Bogutz, A.B.; Zhang, Y.; Zhang, B.; Yu, G.; Xia, W.; et al. SETD2 regulates the maternal epigenome, genomic imprinting and embryonic development. Nat. Genet. 2019, 51, 844–856. [Google Scholar] [CrossRef] [PubMed]
  13. Suzuki, T.; Ichiro Abe, K.; Inoue, A.; Aoki, F. Expression of c-MYC in Nuclear Speckles During Mouse Oocyte Growth and Preimplantation Development. J. Reprod. Dev. 2009, 55, 491–495. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  14. Yu, C.; Cvetesic, N.; Gupta, K.; Ye, T.; Gazdag, E.; Hisler, V.; Negroni, L.; Hajkova, P.; Lenhard, B.; Müller, F.; et al. TBPL2/TFIIA complex overhauls oocyte transcriptome during oocyte growth. bioRxiv 2020. [Google Scholar] [CrossRef]
  15. Vigneault, C.; McGraw, S.; Sirard, M.A. Spatiotemporal expression of transcriptional regulators in concert with the maternal-to-embryonic transition during bovine in vitro embryogenesis. Reproduction 2009, 137, 13–21. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  16. Huang, D.W.; Sherman, B.T.; Lempicki, R.A. Systematic and integrative analysis of large gene lists using DAVID bioinformatics resources. Nat. Protoc. 2008, 4, 44–57. [Google Scholar] [CrossRef] [PubMed]
  17. Sitbon, D.; Boyarchuk, E.; Dingli, F.; Loew, D.; Almouzni, G. Histone variant H3.3 residue S31 is essential for Xenopus gastrulation regardless of the deposition pathway. Nat. Commun. 2020, 11, 1256. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  18. Downs, K.M.; Martin, G.R.; Bishop, J.M. Contrasting patterns of myc and N-myc expression during gastrulation of the mouse embryo. Genes Dev. 1989, 3, 860–869. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  19. Langer, D.; Martianov, I.; Alpern, D.; Rhinn, M.; Keime, C.; Dollé, P.; Mengus, G.; Davidson, I. Essential role of the TFIID subunit TAF4 in murine embryogenesis and embryonic stem cell differentiation. Nat. Commun. 2016, 7, 11063. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  20. Villarreal, X.C.; Richter, J.D. Analysis of ATF2 gene expression during early Xenopus laevis development. Gene 1995, 153, 225–229. [Google Scholar] [CrossRef]
  21. Argelaguet, R.; Velten, B.; Arnol, D.; Dietrich, S.; Zenz, T.; Marioni, J.C.; Buettner, F.; Huber, W.; Stegle, O. Multi-Omics Factor Analysis—A framework for unsupervised integration of multi-omics datasets. Mol. Syst. Biol. 2018, 14, e8124. [Google Scholar] [CrossRef] [PubMed]
Figure 1. Two-dimensional embedding of singular-value vectors, u 2 j , computed by HOSVD applied to x j k in Dataset 1 (Table 3). Upper: u 2 j , 1 2 20 when only DNA methylation and accessibility ( k = 2 , 3 ) are integrated. Lower: u 2 j , 1 2 30 when all three omics data points ( 1 k 3 ) are integrated. Default settings other than custom.config$n_neighbors = 100 were used.
Figure 1. Two-dimensional embedding of singular-value vectors, u 2 j , computed by HOSVD applied to x j k in Dataset 1 (Table 3). Upper: u 2 j , 1 2 20 when only DNA methylation and accessibility ( k = 2 , 3 ) are integrated. Lower: u 2 j , 1 2 30 when all three omics data points ( 1 k 3 ) are integrated. Default settings other than custom.config$n_neighbors = 100 were used.
Genes 12 01442 g001
Figure 2. Two-dimensional embedding of singular-value vectors, u 2 j , computed by HOSVD applied to x j k in Dataset 2 (Table 4). Upper: u 2 j , 1 2 20 when only DNA methylation and accessibility ( k = 2 , 3 ) are integrated. Lower: u 2 j , 1 2 30 when all three omics data points ( 1 k 3 ) are integrated. Default settings other than custom.config$n_neighbors = 100 were used.
Figure 2. Two-dimensional embedding of singular-value vectors, u 2 j , computed by HOSVD applied to x j k in Dataset 2 (Table 4). Upper: u 2 j , 1 2 20 when only DNA methylation and accessibility ( k = 2 , 3 ) are integrated. Lower: u 2 j , 1 2 30 when all three omics data points ( 1 k 3 ) are integrated. Default settings other than custom.config$n_neighbors = 100 were used.
Genes 12 01442 g002
Table 1. The number of single cells within individual cell types included in Dataset 1.
Table 1. The number of single cells within individual cell types included in Dataset 1.
FGOGO1GO2GranulosaImmuneMIMIIStromaC1StromaC2
814046932015590189185
Table 2. The number of single cells at four embryonic time points included in Dataset 2. For E7.5, the gene expression profiles of 296 single cells were measured.
Table 2. The number of single cells at four embryonic time points included in Dataset 2. For E7.5, the gene expression profiles of 296 single cells were measured.
E4.5-5.5E6.5E6.75E7.5
2679897390 (296)
Table 3. Number of singular-value vectors coincident with classification shown in Table 1.
Table 3. Number of singular-value vectors coincident with classification shown in Table 1.
SVD ( v jk )HOSVD ( u 2 j )
AdjustedGeneDNADNADNA Methylation
p-ValueExpressionMethylationAccessibilityand AccessibilityAll
<0.0110711018
≥0.010391012
Table 4. Number of singular-value vectors coincident with the classification shown in Table 2.
Table 4. Number of singular-value vectors coincident with the classification shown in Table 2.
SVD ( v jk )HOSVD ( u 2 j )
AdjustedGeneDNADNADNA Methylation
p-ValueExpressionMethylationAccessibilityand AccessibilityAll
<0.0110751018
≥0.010351012
Table 5. Number of single cells, features, nonzero components, and their ratios.
Table 5. Number of single cells, features, nonzero components, and their ratios.
NumbersExpressionDNA MethylationDNA Accessibility
Dataset 1
single cells899899899
features26,50026,438,80715,478,375
total components 2.38 × 10 7 2.38 × 10 10 1.39 × 10 10
nonzero components 6.76 × 10 6 5.50 × 10 8 3.85 × 10 8
the ratio of nonzero components0.280.020.03
Data set 2
single cells758852852
features22,08420,106,50713,627,678
total components 1.67 × 10 7 1.71 × 10 10 1.16 × 10 10
nonzero components 4.87 × 10 6 6.96 × 10 8 7.87 × 10 8
the ratio of nonzero components0.290.040.07
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Taguchi, Y.-h.; Turki, T. Tensor-Decomposition-Based Unsupervised Feature Extraction in Single-Cell Multiomics Data Analysis. Genes 2021, 12, 1442. https://0-doi-org.brum.beds.ac.uk/10.3390/genes12091442

AMA Style

Taguchi Y-h, Turki T. Tensor-Decomposition-Based Unsupervised Feature Extraction in Single-Cell Multiomics Data Analysis. Genes. 2021; 12(9):1442. https://0-doi-org.brum.beds.ac.uk/10.3390/genes12091442

Chicago/Turabian Style

Taguchi, Y-h., and Turki Turki. 2021. "Tensor-Decomposition-Based Unsupervised Feature Extraction in Single-Cell Multiomics Data Analysis" Genes 12, no. 9: 1442. https://0-doi-org.brum.beds.ac.uk/10.3390/genes12091442

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop