Next Article in Journal
In Situ Synthesis of MnMgFe-LDH on Biochar for Electrochemical Detection and Removal of Cd2+ in Aqueous Solution
Next Article in Special Issue
Neighbourhood Sum Degree-Based Indices and Entropy Measures for Certain Family of Graphene Molecules
Previous Article in Journal
Immunomodulatory Activity of Punicalagin, Punicalin, and Ellagic Acid Differs from the Effect of Pomegranate Peel Extract
Previous Article in Special Issue
Connecting SiO4 in Silicate and Silicate Chain Networks to Compute Kulli Temperature Indices
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Cascade Forest-Based Model for Prediction of RNA Velocity

School of Mathematics, Physics and Statistics, Shanghai University of Engineering Science, Shanghai 201620, China
*
Author to whom correspondence should be addressed.
Molecules 2022, 27(22), 7873; https://doi.org/10.3390/molecules27227873
Submission received: 18 October 2022 / Revised: 8 November 2022 / Accepted: 10 November 2022 / Published: 15 November 2022
(This article belongs to the Special Issue Study of Molecules in the Light of Spectral Graph Theory)

Abstract

:
In recent years, single-cell RNA sequencing technology (scRNA-seq) has developed rapidly and has been widely used in biological and medical research, such as in expression heterogeneity and transcriptome dynamics of single cells. The investigation of RNA velocity is a new topic in the study of cellular dynamics using single-cell RNA sequencing data. It can recover directional dynamic information from single-cell transcriptomics by linking measurements to the underlying dynamics of gene expression. Predicting the RNA velocity vector of each cell based on its gene expression data and formulating RNA velocity prediction as a classification problem is a new research direction. In this paper, we develop a cascade forest model to predict RNA velocity. Compared with other popular ensemble classifiers, such as XGBoost, RandomForest, LightGBM, NGBoost, and TabNet, it performs better in predicting RNA velocity. This paper provides guidance for researchers in selecting and applying appropriate classification tools in their analytical work and suggests some possible directions for future improvement of classification tools.

1. Introduction

With the rapid development and innovation of single-cell RNA sequencing (scRNA-seq) technology and related bioinformatics methods [1,2,3,4,5,6,7,8], high-throughput single-cell data are emerging in large quantities, and “scRNA-seq technology” has become an important tool for molecular biology research. Compared with traditional cell-based RNA-seq, scRNA-seq can better reflect the molecular biological processes within a specific cell population. Currently, the use of single-cell RNA sequencing (scRNA-seq) data for cell trajectory inference is one of the pressing research issues [9,10,11,12,13,14,15]. Many researchers have proposed many algorithms for cell trajectory inference, for example, TSCAN [16] constructs a minimum spanning tree (MST) based on the center of mass of a cluster of cells and then infers the pseudo-temporal order of cells. There is also a class of algorithms to infer trajectories based on the graph structure. For instance, Wanderlust [17] and SLICER [18] construct intercellular graphs based on KNN graphs, and SoptSC [19] uses intercellular similarity matrices for inferring trajectories.
La Manno et al. [20] introduce the concept of RNA velocity. This concept develops new ways to study cellular dynamics by linking data to underlying molecular dynamics. Therefore, the predictive models of cellular dynamics can be achieved. RNA velocity is an indicator of transcript dynamics that predicts future changes in cellular state, and it allows for reliable estimation of relative temporal derivatives of gene expression state for studies of cell differentiation, lineage development, and dynamic changes in cellular components in the tumor microenvironment. RNA velocity recovers targeted information by distinguishing between newly transcribed pre mRNA (unspliced) and mature mRNA (spliced), the latter of which can be detected from the presence of introns in standard single-cell RNA-seq protocols. The change in mRNA abundance is referred to as RNA velocity. La Manno et al. [20] propose the original steady-state model algorithm, named velocyto, for RNA velocity assumes that the transcriptional phase lasts long enough to reach steady-state equilibrium and that equilibrium mRNA levels can be approximated by simplifying linear regression with co-splicing rates. Volker Bergen et al. [21] propose a model called scVelo algorithm, which includes a stochastic, kinetic model and steady-state model.
Wang et al. [22] take a bold stab at RNA velocity research by using RNA velocity prediction as a supervised learning problem for classification, dividing the cell state space into segments of equal size by direction as classes. The estimated RNA velocity vector is treated as ground truth, which we counted as a true positive if the predicted direction is located in the same segment as the original target direction, and so on. In this paper, we study the supervised learning problem based on RNA velocity prediction classification using internally generated mixed cell lineage datasets and a number of complex public datasets, which are well annotated with cell-type labels. We evaluate six integrated classifiers (XGBoost [23], RandomForest [24], LightGBM [25], NGBoost [26], TabNet [27], Cascade Forest [28]) in the problem of RNA velocity prediction. This can make biologically meaningful predictions.
The paper is organized as followed. The second section introduces the concept and theory of RNA velocity estimation. The cascade forest structure model and the evaluation indicators to be used in subsequent experiments are introduced in this chapter. Finally, the information of the relevant data set is briefly described. In the third section, experimental results are analyzed, such as preprocessing the data set, evaluating the experimental results of the data set, using accuracy, the kappa coefficient, and evaluating the benchmark performance of the classifier. Finally, the stability of the performance of the cascade forest model is further analyzed by parameter comparison. In the fourth and fifth parts, we review the classification problem of speed prediction and suggest the future direction of classification tools. We believe that the research on RNA velocity prediction will guide the classification of cell velocity prediction and classification tools for scRNA-seq datasets in various use cases.

2. Result

2.1. Data Set

A comprehensive and systematic evaluation of the RNA velocity prediction classification base classifier requires scRNA-seq datasets with well-annotated cell labels, as most of the evaluation metrics rely on the underlying factual label set for their calculation. Therefore, only scRNA-seq datasets with highly plausible cell-type labels are used in this paper. In the numerical experiments in this paper, datasets with different feature dimensions and different numbers of classes were carefully selected to better characterize the performance of the integrated algorithm in the RNA velocity prediction problem.
Gastrulation_e75: A subset of mouse gastrulation is E7.5, in embryonic day 7.5 (E7.5) mutants, revealing a molecular map of mouse gastrulation and early organogenesis, including 7202 from mouse embryos, and a transcriptional profile of 53,801 single cells [29].
Bonemarrow: A human bone marrow cell dataset which consists of hematopoietic cells, bone marrow adipose tissue, and supporting stromal cells, and includes transcript levels of 14,319 genes in 5780 cells [30].
Pancreas: A dataset from the embryonic pancreas of NVF homozygous mice, with transcript levels of 27,998 genes from 3696 pancreatic epithelial and Ngn3-Venus fusion cells [30].
Dentategyrus: A mouse hippocampal dentate gyrus neurogenesis dataset. Comprising RNA-seq data of 13,913 genes and 2930 cells from multiple lineages, the dominant structure is the granulosa cell lineage in which neuroblasts develop into granulosa cells. The remaining populations form distinct cell types that are fully differentiated (e.g., Cajal-Recius cells) or form sub-lineages [31].
As shown in Figure 1, we plotted the splicing ratios of each dataset, and 10–25% of the unspliced molecules in different data using single-cell datasets typically contain intronic sequences.

2.2. Data Preprocessing

As with traditional scRNA-seq analysis, measurements require preprocessing. First, genes were filtered by expression level or their occurrence in cells, retaining genes with sufficient counts, selecting the top 2000 highly variable genes for datasets with less than 3000 cells and then for data with less than 6000 cells and greater than 3000 cells. The top 2500 highly variable genes were selected for the set and, finally, the top 3000 highly variable genes were selected for cells with more than 6000 cells, as shown in Table 1, which provides the specific description of each data set.
For highly variable genes, the expression levels of these genes vary greatly between different cells (highly expressed in some cells and low in others). Screening out highly variable genes can reduce the noise of the dataset to a certain extent. After the first filter, normalization was performed to handle differences in sequencing depth between individual cells, followed by a log transformation, and highly variable genes were identified and extracted, while all remaining genes were discarded. Finally, according to the nearest neighbor graph, the first and second moments were calculated. There are three methods for velocity estimation in scVelo: the steady-state model, stochastic model, and dynamic model.
In this article, we evaluated the classification under the steady-state model and the dynamic model, respectively. From the velocity estimates, we could obtain a multidimensional RNA velocity vector V = { v 1 , v 2 , v n } for each transcriptional state of a single cell. In order to extract relevant signals and infer RNA velocity, the feature selection is performed according to the gene ranking of ScVelo and the first k gene in each cluster is selected as the model feature and, finally, assigned d class labels by an equal division of a 2D circular plane. In the RNA velocity prediction classification problem, in order to better evaluate the effect of each classifier, we set the parameters by default k = 20 , d = 4 ; that is, we selected the top 20 genes in each cluster to divide the RNA speed prediction into four directions.

2.3. Performance Evaluation

For classification performance evaluation in the steady-state mode first, we trained and tested models on four single-cell RNA-seq datasets, dividing the dataset into training and test datasets in an 8:2 ratio, and then matched the training set to these classifier models to extract and learn hidden patterns. Subsequently, the learning of the test dataset was evaluated against accuracy, F1_scores, and kappa scores, and the prediction results were retrieved. To address the data imbalance problem in this paper, an oversampling method SMOTETomek [32] was invoked, which can largely reduce the loss of information and improve the performance of the model. Figure 2 shows the classification accuracy, macro_F1, and Kappa coefficient for all tools in the steady-state mode for the four test cases. A comparative study of all the specified integrated classifiers for the specified metrics shows that we can find that, among datasets with different clipping ratios, the cascade forest model achieves relatively good results, followed by XGBoost and Random Forest, which also perform well in the steady-state mode.
We then ran the dynamics model to learn the full transcriptional dynamics of the splicing dynamics, which was solved in a likelihood-based expectation maximization framework by iteratively estimating the parameters of the response rate and latent cell-specific variables (i.e., transcriptional state and intracellular latency time), and it can be seen in Figure 3 that the cascade forest model continues to perform better than other classifiers in the dynamics model, with good robustness and accuracy in all model. The accuracy, F1_score, and kappa are still the highest and have improved significantly, reaching 0.937 in the dentategruys dataset and 0.916 in F1_score and kappa coefficient, respectively. TabNet’s performance, in terms of accuracy and F1_score and kappa coefficients, in the dynamics model was average, and both classifiers seemed to be less sensitive to speed prediction classification in different model.

2.4. Comparison with Existing RNA Velocity Prediction Classification Methods

We compared the stacking model classifier proposed by Wang et al. [22]. We further investigated the effects of hyper-parameter k, which is the number of top genes, and parameter d, which is the number of categories, on cascade forest models and stacked models. In the feature selection part of the parameter k control, Figure 4 shows that when d is set to four, we discover that the accuracy of both methods can increase from the increase in k, which may be that with the increase in features, it contains more useful RNA information, which can make the RNA velocity prediction classification more accurate, and also shows that the accuracy of the cascade forest model in the four datasets is significantly better than that of the stacking model.
With the previous experimental results, we set k to 20, although we can increase k for better performance. Figure 5 shows that, as we continue to increase d, the task becomes more difficult in the stacking model, so the accuracy score decays and fluctuates greatly while the cascade forest still performs well and has good robustness relative to the stacking model.

3. Discussion

This paper introduces a novel machine-learning algorithm cascade forest model for RNA velocity prediction and classification tasks. The cascade forest model is a decision tree ensemble approach that has fewer hyperparameters than deep neural networks and preserves the tree model’s interpretability. Its model complexity can be determined automatically in a data-dependent manner, making cascade forest models work well even on small-scale data. This paper aims to effectively predict RNA velocity using cascade forest models to prove that machine learning (ML) algorithms based on ensemble strategies are effective in predicting RNA velocities. In this paper, experiments were performed on four scRNA-seq datasets with different complexities and splicing ratios. The cascade forest model was comprehensively evaluated with five base classifiers: XGBoost, RandomForest, LightGBM, NGBoost, and TabNet. The experimental results show that the kappa coefficient, accuracy, and F1_score performance of the cascade forest model are significantly better than XGBoost, RandomForest, LightGBM, NGBoost, and TabNet, which proves that the model substantially improves RNA velocity prediction and classification.
In addition, this paper compares the cascade forest model with the stacking model proposed by Wang et al. for RNA velocity prediction and classification. Through parametric analysis, it is found that cascade forests have better stability and stronger robustness. Especially for the change of parameter d, the cascade forest model prediction accuracy will not fluctuate as much as the stacked model, and even the performance will show a significant downward trend. As parameter k increases, the number of features increases, and the cascade forest model can predict RNA velocity more accurately, showing better performance than the stacking model.
In this study, we extensively analyze RNA velocity prediction classification problems. Although the first application of existing RNA velocity models has shown promising results [33], the selection of characteristic genes and the screening of highly variable genes have been found in experimental tests to have different degrees of influence on speed prediction. Methods for assessing gene selection bias, joint models for better potential spatial representation, and factor models for unraveling compositional effects will be further studied, which will be necessary for future work.
Most classification tools accurately predict the results in RNA velocity prediction on four datasets with different splicing ratios. However, this result is based on an ensemble learning framework to balance different sample feature ratios to arrive at different baseline models, but it is still an empirical approach. When the data distribution is incomplete and unbalanced, the prediction results still have a more significant impact. In experimental tests on the Bonemarrow dataset, we found that the accuracy of cascade forest models decreased by more than 20% when the data were unbalanced. Therefore, the interpretability of the model will be a problem that needs to be solved in the future.
In conclusion, cascade forest models provide a new prediction-based method for studying the mechanisms of cell differentiation that can be applied to help attribute state spaces not yet covered by scRNA-seq data. In future work, we can use this interpolated direction information to conduct more in-depth research on trajectory inference. For example, differential geometry is used to extract potential adjustments for estimating the curvature of the differentiation landscape in metabolic labeling experiments [34]. Therefore, the prediction of RNA velocity can more intuitively understand the trend of cell dynamics, which has specific reference significance for biologists’ research.

4. Materials and Methods

4.1. RNA Velocity Estimation

The goal is to predict the RNA velocity vector for each cell based on its gene expression data, shown in 2D space, and to formulate this as a classification problem. For this problem, we first need to obtain a count matrix of unspliced and spliced mRNAs, which can be obtained using methods such as Velocyto [20], loompy/kallisto [35], or alevin [36], to obtain read annotations. After obtaining the count matrices, a simple kinetic model of the sheared expression can be built:
d U ( t ) d t = α ( t ) β ( t ) U ( t )
d S ( t ) d t = β ( t ) U ( t ) γ ( t ) S ( t )
where U ( t ) denotes the number of unspliced mRNA molecules, S ( t ) denotes the number of mRNA molecules after splicing, α denotes the transcription rate, β denotes the splicing rate from unspliced to spliced, and γ denotes the degradation rate of the mRNA product after splicing.

4.2. Steady-State Model

The steady-state model is one of the main models of RNA velocity. This model has two fundamental assumptions: (i) at the gene level, all full splicing dynamics with transcriptional induction, repression, and steady-state mRNA levels are captured; (ii) at the cellular level, all genes have a common splicing rate and gene expression follows steady state. At that time, the steady-state ratio is obtained, d S ( t ) d t = 0 γ ˜ = γ β = u T s | | s | | 2 , where || · || represents the Euclidean distance.
At this time, the cell i velocity is estimated as the deviation of the ratio of spliced to unspliced molecules fitted to γ, which is:
v i = u i γ ˜ s i

4.3. Dynamic Model

In contrast, dynamic models directly solve for the complete transcriptional kinetics of each gene, rather than making transcriptome-wide assumptions. Instead of trying to fit the data into a regression model, it estimates the parameters using an Expectation Maximization algorithm (EM) [37] that uses the maximum likelihood to iteratively approximate α , β , and γ , and learns the spliced/unspliced trajectories of a given gene. This assigns the following likelihood function to each gene:
( θ ) = 1 2 π σ exp ( 1 2 n i n || x i o b s x t i ( θ ) || 2 σ 2 )
where x i o b s = ( u i o b s , s i o b s )   represents the unspliced and spliced mRNA molecules of specific genes in the observed cell i , respectively. x t i denotes the unspliced/spliced molecule i at time t based on the inferred parameter set θ = ( α ,   β ,   γ ) .

4.4. Performance Metrics

In this paper, three predefined metrics are used to evaluate the performance of the five integrated classifiers: accuracy [38], macro_F1 [38], and kappa coefficient [39]. The above metrics can be considered as different combinations from the confusion matrix. Accuracy is a metric used to evaluate classification models and represents the proportion of the total number of correct predictions. The macro_F1 is a variant of the F1-Score in multiclassification evaluation, is a parameter calculated as a harmonic mean of accuracy and recall, and can combine the two metrics well. This paper also considers the Kappa coefficient, an important metric for assessing the accuracy of a multiclassification model.
A c c u r a c y = n c o r r e c t   n t o t a l   = T P + T N T P + F P + T N + F N
P i = T P i T P i + F P i
P m a c r o = i = 1 L P i | L |
R i = T P i T P i + F N i
R m a c r o = i = 1 L R i | L |
M a c r o _ F 1 = 2 P m a c r o R m a c r o P m a c r o + R m a c r o
K a p p a = p 0 p e 1 p e
where TP (true positive) is the number of positive samples correctly identified. FP (false positive) is the number of negative samples identified as positive. TN (true negative) is the number of negative samples correctly identified. FN (false negative) is the number of positive samples missed. p 0 indicates the overall classification accuracy, p e indicates chance consistency, C is the total number of categories, and T i is the number of samples correctly classified for each category. Suppose that the real number of samples for each class is a 1 , a 2 , , a c and the number of samples for each class predicted is b 1 , b 2 , , b c and the total number of samples is n .

4.5. Classification Tool

In this study, we use several popular integrated enhancement algorithms, such as LightGBM [25], XGBoost [26], Random Forest [27], NGBoost [28], and TabNet [35], to evaluate the performance of each classifier in comparison with the cascade forest structure model [36].
After evaluating the five popular methods, we used four of the classifiers, as applied to the cascade forest structure, to predict with good robustness and accuracy. As shown in Figure 6, each level of the cascade forest structure consists of LightGBM, XGBoost, Random Forest, and NGBoost. These different types of integration methods are further integrated to increase diversity, which is crucial from an integration learning perspective. Each classifier will generate a class vector, which is generated by five cross-validations to avoid overfitting. The class vector is then concatenated with the original feature vector and received as input by the next level of the cascade. If the performance of the entire cascade does not improve significantly on the validation set, the propagation of the levels is terminated and therefore the complexity of the model can be determined automatically.

4.6. Availability of Data and Materials

scRNA-seq datasets are all public datasets and can be accessed through https://scvelo.org (accessed on 21 June 2022) direct interview. The hippocampal dentate gyrus neurogenesis dataset at P12 and P35 is available from the Gene Expression Omnibus (GEO) with accession number GSE95753. Atlas of mouse gastrulation is available under accession number GSE87038. Mouse pancreas data is also available from NCBI GEO, accession ID GSE132188. Human bone marrow data is available through the Human Cell Atlas data portal.

5. Conclusions

In summary, the supervised learning problem of RNA velocity prediction problem as classification is an entirely new study, and researchers still face many challenges. This study’s comprehensive evaluation was made using accuracy, F1_score, and kappa coefficients. We have demonstrated that the cascade forest model can work well in RNA velocity prediction classification problems, and its performance is better than XGBoost, RandomForest, LightGBM, NGBoost, TabNet, and stacking models, which are currently popular classification algorithms. Compared with the above classification algorithms, the cascade forest model is more stable and robust. Therefore, the cascade forest model can be better applied to any scRNA-seq data that can estimate RNA velocity. It guides researchers in selecting and applying appropriate classification tools in their analytical work and provides some possible directions for future improvements to classification tools.
Although the problem of modeling dynamics in scRNA-seq using RNA velocity is tricky, the test results in this paper suggest that it is feasible to incorporate classification into single-cell velocity predictive analysis workflows. Cascade forest models allow us to predict and infer the future expression of individual cells more accurately. In current applications, we can use it to analyze influencing genes in trajectory branching events. There are many other applications of this analysis that are worth exploring. We demonstrate that the cascade forest model substantially improves over previously proposed RNA velocity prediction methods on relevant real-world datasets from human and mouse developmental brains.

Author Contributions

Z.Z. proposed the model and completed the manuscript writing; Y.P. and X.H. assisted in completing the model construction; S.Z. and Z.Y. reviewed and revised the manuscript; and Z.Y. also provided financial support. All authors have read and agreed to the published version of the manuscript.

Funding

This research was supported by National Natural Science Foundation of China (No: 62072296).

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

Data are contained within the article.

Conflicts of Interest

The authors declare no conflict of interest.

Sample Availability

Not applicable.

References

  1. Gierahn, T.M.; Wadsworth, M.H.; Hughes, T.K.; Bryson, B.D.; Butler, A.; Satija, R.; Fortune, S.; Love, J.C.; Shalek, A.K. Seq-Well: Portable, low-cost RNA sequencing of single cells at high throughput. Nat. Methods 2017, 14, 395–398. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  2. Klein, A.M.; Mazutis, L.; Akartuna, I.; Tallapragada, N.; Veres, A.; Li, V.; Peshkin, L.; Weitz, D.A.; Kirschner, M.W. Droplet barcoding for single-cell transcriptomics applied to embryonic stem cells. Cell 2015, 161, 1187–1201. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  3. Macosko, E.Z.; Basu, A.; Satija, R.; Nemesh, J.; Shekhar, K.; Goldman, M.; Tirosh, I.; Bialas, A.R.; Kamitaki, N.; Martersteck, E.M. Highly parallel genome-wide expression profiling of individual cells using nanoliter droplets. Cell 2015, 161, 1202–1214. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  4. Picelli, S.; Björklund, Å.K.; Faridani, O.R.; Sagasser, S.; Winberg, G.; Sandberg, R. Smart-seq2 for sensitive full-length transcriptome profiling in single cells. Nat. Methods 2013, 10, 1096–1098. [Google Scholar] [CrossRef] [PubMed]
  5. Zheng, G.X.; Terry, J.M.; Belgrader, P.; Ryvkin, P.; Bent, Z.W.; Wilson, R.; Ziraldo, S.B.; Wheeler, T.D.; McDermott, G.P.; Zhu, J. Massively parallel digital transcriptional profiling of single cells. Nat. Commun. 2017, 8, 14049. [Google Scholar] [CrossRef] [Green Version]
  6. Han, X.; Wang, R.; Zhou, Y.; Fei, L.; Sun, H.; Lai, S.; Saadatpour, A.; Zhou, Z.; Chen, H.; Ye, F. Mapping the mouse cell atlas by microwell-seq. Cell 2018, 172, 1091–1107.e17. [Google Scholar] [CrossRef] [Green Version]
  7. Fan, H.C.; Fu, G.K.; Fodor, S.P. Combinatorial labeling of single cells for gene expression cytometry. Science 2015, 347, 1258367. [Google Scholar] [CrossRef]
  8. Guo, F.; Yin, Z.; Zhou, K.; Li, J. PLncWX: A Machine-Learning Algorithm for Plant lncRNA Identification Based on WOA-XGBoost. J. Chem. 2021, 2021, 6256021. [Google Scholar] [CrossRef]
  9. Haghverdi, L.; Büttner, M.; Wolf, F.A.; Buettner, F.; Theis, F.J. Diffusion pseudotime robustly reconstructs lineage branching. Nat. Methods 2016, 13, 845–848. [Google Scholar] [CrossRef] [Green Version]
  10. Setty, M.; Tadmor, M.D.; Reich-Zeliger, S.; Angel, O.; Salame, T.M.; Kathail, P.; Choi, K.; Bendall, S.; Friedman, N.; Pe’er, D. Wishbone identifies bifurcating developmental trajectories from single-cell data. Nat. Biotechnol. 2016, 34, 637–645. [Google Scholar] [CrossRef]
  11. Trapnell, C.; Cacchiarelli, D.; Grimsby, J.; Pokharel, P.; Li, S.; Morse, M.; Lennon, N.J.; Livak, K.J.; Mikkelsen, T.S.; Rinn, J.L. The dynamics and regulators of cell fate decisions are revealed by pseudotemporal ordering of single cells. Nat. Biotechnol. 2014, 32, 381–386. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  12. Cannoodt, R.; Saelens, W.; Saeys, Y. Computational methods for trajectory inference from single-cell transcriptomics. Eur. J. Immunol. 2016, 46, 2496–2506. [Google Scholar] [CrossRef] [PubMed]
  13. Wolf, F.A.; Hamey, F.K.; Plass, M.; Solana, J.; Dahlin, J.S.; Göttgens, B.; Rajewsky, N.; Simon, L.; Theis, F.J. PAGA: Graph abstraction reconciles clustering with trajectory inference through a topology preserving map of single cells. Genome Biol. 2019, 20, 59. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  14. Saelens, W.; Cannoodt, R.; Todorov, H.; Saeys, Y. A comparison of single-cell trajectory inference methods. Nat. Biotechnol. 2019, 37, 547–554. [Google Scholar] [CrossRef]
  15. Zhou, K.; Yin, Z.; Guo, F.; Li, J. Application of Combined Prediction Model Based on Core and Coritivity Theory in Continuous Blood Pressure Prediction. Comb. Chem. High Throughput Screen. 2022, 25, 579–585. [Google Scholar] [CrossRef]
  16. Ji, Z.; Ji, H. TSCAN: Pseudo-time reconstruction and evaluation in single-cell RNA-seq analysis. Nucleic Acids Res. 2016, 44, e117. [Google Scholar] [CrossRef] [Green Version]
  17. Bendall, S.C.; Davis, K.L.; Amir, E.-a.D.; Tadmor, M.D.; Simonds, E.F.; Chen, T.J.; Shenfeld, D.K.; Nolan, G.P.; Pe’er, D. Single-cell trajectory detection uncovers progression and regulatory coordination in human B cell development. Cell 2014, 157, 714–725. [Google Scholar] [CrossRef] [Green Version]
  18. Welch, J.D.; Hartemink, A.J.; Prins, J.F. SLICER: Inferring branched, nonlinear cellular trajectories from single cell RNA-seq data. Genome Biol. 2016, 17, 106. [Google Scholar] [CrossRef] [Green Version]
  19. Wang, S.; MacLean, A.L.; Nie, Q. SoptSC: Similarity matrix optimization for clustering, lineage, and signaling inference. bioRxiv 2018, 168922. [Google Scholar] [CrossRef] [Green Version]
  20. La Manno, G.; Soldatov, R.; Zeisel, A.; Braun, E.; Hochgerner, H.; Petukhov, V.; Lidschreiber, K.; Kastriti, M.E.; Lönnerberg, P.; Furlan, A. RNA velocity of single cells. Nature 2018, 560, 494–498. [Google Scholar] [CrossRef]
  21. Bergen, V.; Lange, M.; Peidli, S.; Wolf, F.A.; Theis, F.J. Generalizing RNA velocity to transient cell states through dynamical modeling. Nat. Biotechnol. 2020, 38, 1408–1414. [Google Scholar] [CrossRef] [PubMed]
  22. Wang, X.; Zheng, J. Velo-Predictor: An ensemble learning pipeline for RNA velocity prediction. BMC Bioinform. 2021, 22, 419. [Google Scholar] [CrossRef]
  23. Chen, T.; He, T.; Benesty, M.; Khotilovich, V.; Tang, Y.; Cho, H.; Chen, K.; Mitchell, R.; Cano, I.; Zhou, T. Xgboost: Extreme Gradient Boosting; R Package Version 0.71. 2.; Grin Verlag: München, Germnay, 2018. [Google Scholar]
  24. Rumpf, H. The characteristics of systems and their changes of state disperse. In Particle Technology, Chapman and Hall; Springer: Berlin/Heidelberg, Germany, 1990; pp. 8–54. [Google Scholar]
  25. Ke, G.; Meng, Q.; Finley, T.; Wang, T.; Chen, W.; Ma, W.; Ye, Q.; Liu, T.-Y. Lightgbm: A highly efficient gradient boosting decision tree. In Proceedings of the 31st International Conference on Neural Information Processing Systems, Long Beach, CA, USA, 4–9 December 2017. [Google Scholar]
  26. Duan, T.; Anand, A.; Ding, D.Y.; Thai, K.K.; Basu, S.; Ng, A.; Schuler, A. Ngboost: Natural gradient boosting for probabilistic prediction. In Proceedings of the International Conference on Machine Learning (PMLR), Virtual Event, 13–18 July 2020; pp. 2690–2700. [Google Scholar]
  27. Arik, S.Ö.; Pfister, T. Tabnet: Attentive interpretable tabular learning. In Proceedings of the AAAI Conference on Artificial Intelligence, Virtual Event, 2–9 February 2021; pp. 6679–6687. [Google Scholar]
  28. Zhou, Z.-H.; Feng, J. Deep forest. Natl. Sci. Rev. 2019, 6, 74–86. [Google Scholar] [CrossRef] [Green Version]
  29. Pijuan-Sala, B.; Griffiths, J.A.; Guibentif, C.; Hiscock, T.W.; Jawaid, W.; Calero-Nieto, F.J.; Mulas, C.; Ibarra-Soria, X.; Tyser, R.C.; Ho, D.L.L. A single-cell molecular map of mouse gastrulation and early organogenesis. Nature 2019, 566, 490–495. [Google Scholar] [CrossRef] [PubMed]
  30. Bastidas-Ponce, A.; Tritschler, S.; Dony, L.; Scheibner, K.; Tarquis-Medina, M.; Salinno, C.; Schirge, S.; Burtscher, I.; Böttcher, A.; Theis, F.J. Comprehensive single cell mRNA profiling reveals a detailed roadmap for pancreatic endocrinogenesis. Development 2019, 146, dev173849. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  31. Hochgerner, H.; Zeisel, A.; Lönnerberg, P.; Linnarsson, S. Conserved properties of dentate gyrus neurogenesis across postnatal development revealed by single-cell RNA sequencing. Nat. Neurosci. 2018, 21, 290–299. [Google Scholar] [CrossRef] [PubMed]
  32. Goel, G.; Maguire, L.; Li, Y.; McLoone, S. Evaluation of sampling methods for learning from imbalanced data. In Proceedings of the International Conference on Intelligent Computing, Nanning, China, 28–31 July 2013; Springer: Berlin/Heidelberg, Germany, 2013; pp. 392–401. [Google Scholar]
  33. Slyper, M.; Porter, C.; Ashenberg, O.; Waldman, J.; Drokhlyansky, E.; Wakiro, I.; Smillie, C.; Smith-Rosario, G.; Wu, J.; Dionne, D. A single-cell and single-nucleus RNA-Seq toolbox for fresh and frozen human tumors. Nat. Med. 2020, 26, 792–802. [Google Scholar] [CrossRef]
  34. Gorin, G.; Fang, M.; Chari, T.; Pachter, L. RNA velocity unraveled. bioRxiv 2022. [Google Scholar] [CrossRef]
  35. Melsted, P.; Booeshaghi, A.; Liu, L.; Gao, F.; Lu, L.; Min, K.H.J.; da Veiga Beltrame, E.; Hjörleifsson, K.E.; Gehring, J.; Pachter, L. Modular, efficient and constant-memory single-cell RNA-seq preprocessing. Nat. Biotechnol. 2021, 39, 813–818. [Google Scholar] [CrossRef]
  36. Srivastava, A.; Malik, L.; Smith, T.; Sudbery, I.; Patro, R. Alevin efficiently estimates accurate gene abundances from dscRNA-seq data. Genome Biol. 2019, 20, 65. [Google Scholar] [CrossRef]
  37. Moon, T.K. The expectation-maximization algorithm. IEEE Signal Process. Mag. 1996, 13, 47–60. [Google Scholar] [CrossRef]
  38. Hossin, M.; Sulaiman, M.N. A review on evaluation metrics for data classification evaluations. Int. J. Data Min. Knowl. Manag. Process 2015, 5, 1. [Google Scholar]
  39. Vieira, S.M.; Kaymak, U.; Sousa, J.M. Cohen’s kappa coefficient as a performance measure for feature selection. In Proceedings of the International Conference on Fuzzy Systems, Barcelona, Spain, 18–23 July 2010; IEEE: Piscataway Township, NJ, USA, 2010; pp. 1–8. [Google Scholar]
Figure 1. The distribution of spliced to unspliced proportions of cell types in different datasets.
Figure 1. The distribution of spliced to unspliced proportions of cell types in different datasets.
Molecules 27 07873 g001
Figure 2. Evaluation of classification performance indicators for steady-state model RNA velocity prediction. (A) Accuracy of the classifiers. (B) Macro_F1 of the classifiers. (C) Kappa coefficients of the classifiers.
Figure 2. Evaluation of classification performance indicators for steady-state model RNA velocity prediction. (A) Accuracy of the classifiers. (B) Macro_F1 of the classifiers. (C) Kappa coefficients of the classifiers.
Molecules 27 07873 g002
Figure 3. Evaluation of classification performance indicators for dynamic model RNA velocity prediction. (A) Accuracy of the classifiers. (B) Macro_F1 of the classifiers. (C) Kappa coefficients of the classifiers.
Figure 3. Evaluation of classification performance indicators for dynamic model RNA velocity prediction. (A) Accuracy of the classifiers. (B) Macro_F1 of the classifiers. (C) Kappa coefficients of the classifiers.
Molecules 27 07873 g003
Figure 4. The effects of hyper-parameter k. (AD) Performance of cascade forest models and stacking models under different datasets and different parameters k.
Figure 4. The effects of hyper-parameter k. (AD) Performance of cascade forest models and stacking models under different datasets and different parameters k.
Molecules 27 07873 g004
Figure 5. The effects of hyper-parameter d. (AD) Performance of cascade forest models and stacking models under different datasets and different parameters d.
Figure 5. The effects of hyper-parameter d. (AD) Performance of cascade forest models and stacking models under different datasets and different parameters d.
Molecules 27 07873 g005
Figure 6. Diagrammatic representation of the cascade forest structure.
Figure 6. Diagrammatic representation of the cascade forest structure.
Molecules 27 07873 g006
Table 1. Description of cells and genes in each dataset.
Table 1. Description of cells and genes in each dataset.
DatasetsCell NumberGene NumberHighly Variable GenesFeature Numbers
(k = 20)
gastrulation_e75720253,8013000291
bonemarrow578014,3192500141
pancreas369627,9982500143
dantategrus293013,9132000151
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Zeng, Z.; Zhao, S.; Peng, Y.; Hu, X.; Yin, Z. Cascade Forest-Based Model for Prediction of RNA Velocity. Molecules 2022, 27, 7873. https://doi.org/10.3390/molecules27227873

AMA Style

Zeng Z, Zhao S, Peng Y, Hu X, Yin Z. Cascade Forest-Based Model for Prediction of RNA Velocity. Molecules. 2022; 27(22):7873. https://doi.org/10.3390/molecules27227873

Chicago/Turabian Style

Zeng, Zhiliang, Shouwei Zhao, Yu Peng, Xiang Hu, and Zhixiang Yin. 2022. "Cascade Forest-Based Model for Prediction of RNA Velocity" Molecules 27, no. 22: 7873. https://doi.org/10.3390/molecules27227873

APA Style

Zeng, Z., Zhao, S., Peng, Y., Hu, X., & Yin, Z. (2022). Cascade Forest-Based Model for Prediction of RNA Velocity. Molecules, 27(22), 7873. https://doi.org/10.3390/molecules27227873

Article Metrics

Back to TopTop