Abstract
The cell cycle is composed of a series of ordered, highly regulated processes through which a cell grows and duplicates its genome and eventually divides into two daughter cells. According to the complex changes in cell structure and biosynthesis, the cell cycle is divided into four phases: gap 1 (G1), DNA synthesis (S), gap 2 (G2), and mitosis (M). Determining which cell cycle phases a cell is in is critical to the research of cancer development and pharmacy for targeting cell cycle. However, current detection methods have the following problems: (1) they are complicated and time consuming to perform, and (2) they cannot detect the cell cycle on a large scale. Rapid developments in single-cell technology have made dissecting cells on a large scale possible with unprecedented resolution. In the present research, we construct efficient classifiers and identify essential gene biomarkers based on single-cell RNA sequencing data through Boruta and three feature ranking algorithms (e.g., mRMR, MCFS, and SHAP by LightGBM) by utilizing four advanced classification algorithms. Meanwhile, we mine a series of classification rules that can distinguish different cell cycle phases. Collectively, we have provided a novel method for determining the cell cycle and identified new potential cell cycle-related genes, thereby contributing to the understanding of the processes that regulate the cell cycle.
1. Introduction
Cell proliferation is one of the basic biological activities in the growth and development of living organisms. The sequence of events that occur during the cell proliferation process is generally termed as the cell cycle, which is usually divided into four phases, namely, gap 1 (G1), DNA synthesis (S), gap 2 (G2), and mitosis (M) [1]. In eukaryotes, cells in different cell cycle phases have specific gene expression patterns that help them perform functions that are specific to that phase [2]. Several researchers have reported that the dysregulation of such cell cycle-specific gene expressions leads to the deregulation of the cell cycle, thereby causing abnormal cell proliferation and the production of cancer-associated cells [3, 4]. In addition, drugs that target the cell cycle to treat cancer tend to target cells that are in specific cell cycle phases [5]. The identification of the cell cycle phases and their associated genes has not only made a significant contribution to the study of cancer development but has also had an indelible role in the development of targeted cell cycle therapeutics.
Cell cycle phase transitions are tightly coordinated, thereby making it difficult to efficiently isolate cells from one phase to the next. From the past to the present, researchers have mainly detected cells at different phases by using the following methods. Initially, Potten et al. used the percentage-labeled mitosis method to determine the cell cycle by counting the percentage of labeled mitotic cells [6]. Subsequently, researchers combined PI staining and flow cytometry to distinguish the cells of different phases by using the characteristics of different DNA and RNA contents in each phase [7]. Nowadays, the most commonly used FUCCI technique focuses on differentiating the cell cycle by identifying two overexpressed cell cycle-regulating proteins, geminin and Cdt1, which are combined with fluorescent motifs to make cells appear different colors at various times [8]. However, all these methods have the following disadvantages: time consuming and difficult to identify cells on a large scale.
Cell cycle regulatory genes are expressed periodically during the cell cycle phase, and the identification and investigation of these genes can provide insight into the cell cycle process. In the past, cell cycle regulatory genes have been identified by microarray technology that identifies differentially expressed genes in synchronized cells that are in different cell cycle phases [9]. However, even with the advanced synchronization techniques, synchronization loss can occur within a few cycles [10]. This loss of synchronization and the noise of the microarray analysis can eventually lead to biased results. In recent years, with the use of machine learning methods on biological data, several computational methods for mining cell cycle genes have emerged. Liu et al. used a convolutional neural network to dissect the expression pattern of cell cycle genes in yeast [11]. Cui et al. constructed a deep learning computational framework for identifying periodically expressed genes [12]. However, the identification of cell cycle phase marker genes in humans with high resolution is still a challenge.
Rapid developments in single-cell technology have made it possible to dissect cells on a large scale with unprecedented resolution. Sequencing for individual cells facilitates our study of gene expression within cells. Meanwhile, how to assign cells to various stages of the cell cycle based on their transcriptional profiles has become a research hotspot [13]. In the Seurat and Scran packages, discriminating the stage of the cell cycle is mainly performed by using a priori cell cycle-specific expression gene set to score individual cells for each phase [14, 15]. Grun et al. identified oscillatory genes and used them to determine the cell cycle phase of a single cell [16]. These methods use known gene sets to make determinations and are unable to mine new cell cycle-related genes. Cyclum and cyclops, as two unsupervised learning methods, identify cell cycle phases in the scRNA-seq data by projecting high-dimensional single cells onto a low-dimensional cyclic periodic trajectory [17, 18]. However, the process of dimensionality reduction often leads to information loss. Therefore, we need to continuously explore new sets of cell cycle-related genes by employing efficient and accurate classification methods based on the significance of cell cycle studies.
In this study, we identify a number of cell cycle-related genes and classification rules using supervised machine learning approaches based on a publicly released single-cell dataset. First, we filter the gene features using Boruta filtering method and then rank the filtered features using three effective feature selection methods (e.g., max-relevance and min-redundancy (mRMR) [19], Monte Carlo feature selection (MCFS) [20], and SHAP by LightGBM [21]). The sequenced feature lists are then used as input to four efficient classification algorithms using incremental feature selection (IFS) methods [22]. After analyzing the performance of classification algorithms and optimal features, we obtain some genes that have been reported and confirmed to be associated with the cell cycle, demonstrating the accuracy of our analysis. Also, some genes that have not been explicitly reported to be associated with the cell cycle are discovered, thereby demonstrating the potential of our analysis in mining new cell cycle-associated genes. In addition, we establish rules for distinguishing different cell cycle phases. Overall, our study provides a novel computational method to predict the cell cycle phase at the single-cell level and identifies several cell cycle-related genes that have not been reported yet. The top-ranked features and decision rules identified by our analysis contribute to a better understanding about the underlying mechanism in cell cycle regulation.
2. Materials and Methods
2.1. Data
The single-cell RNA sequencing data of human U2OS cells at different cell cycles are downloaded from the GEO database under the accession number GSE146773 (https://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE146773) [23]. This data includes cells from three different cell cycle phases with the following numbers: 346 G1 phase, 387 G2/M phase, and 334 S phase. U2OS FUCCI cells in either G2 or M phase exhibit green signals, so we refer to the cells from these two periods collectively as G2/M. For each cell, the expression levels of 42,728 genes are quantified using transcript per million (TPM) method.
2.2. Boruta Feature Filtering
Among all features, most of them are irrelevant to the classification. If all features are selected for subsequent analysis, it will introduce redundancy and noise, which can lead to biased calculations. Here, we apply the Boruta [24] method to filter out irrelevant features.
Boruta is a fully correlated feature selection method based on random forest (RF). That is, it attempts to find all features that carry significant information used for prediction rather than finding some compact subset of features that have the least possible classification error. The Boruta algorithm consists of the following steps: (1) a shadow variable is created for each explanatory variable, thereby generating the expanded data. (2) RF model is applied to this expanded data for evaluating the importance of each variable. (3) A z-score of accuracy loss is calculated for each variable, including the original and shadow variables. (4) Track the original attribute z-scores that are significantly higher than the maximum of the shadow attribute z-score. The above steps were repeated until all features are confirmed or rejected. Original attributes with a statistically significant higher z-score than the shadow attribute's maximum z-score are considered relevant for prediction.
In this study, we opt for the Boruta program from https://github.com/scikit-learn-contrib/boruta_py and select the default parameters for the subsequent analysis.
2.3. Feature Ranking Algorithms
Here, we use three feature ranking algorithms (mRMR, MCFS, and SHAP values by LightGBM) to rank the features filtered by Boruta. The details of three methods are described as follows.
2.3.1. Max-Relevance and Min-Redundancy
mRMR is a filtered feature selection algorithm that maximizes the correlation between features and targets and reduces redundancy between selected features [19]. The algorithm treats each feature and output category as separate variables and uses mutual information to measure the similarity between the two variables, with the following expression:
(1) |
where p(x, y) represents the joint probabilistic density of x and y. p(x) and p(y) represent the marginal probabilistic densities of x and y, respectively. In the mRMR process, the correlation between the feature set and the target needs to be calculated each time when a feature is added. Although the correlation between features and targets is high, the interfeature dependence could also be very high. Thus, achieving minimum redundancy is necessary. The formulas for maximum correlation and minimum redundancy are expressed as follows:
(2) |
where S is the feature subset, |S| is the number of features, fi is the i-th feature, and c is the target variable. Finally, the maximum correlation D is combined with the minimum redundancy R to make an optimization equation. Features are selected by maximizing the equation.
However, such feature subset is difficult to find out. mRMR adopted a feasible scheme to sort all investigated features. Features are selected one by one using the criteria of maximum correlation and minimum redundancy; that is, one feature is selected in each round, which has maximum correlation to target variable and minimum redundancy to already-selected features. After all features have been selected, a feature list is generated according to the selection order of features. In the present study, we use the mRMR program from http://home.penglab.com/proj/mRMR/ and perform the analysis according to the default parameters.
2.3.2. Monte Carlo Feature Selection
The MCFS algorithm is a method for importance assessment of features based on decision trees (DTs) [20]. The algorithm is originally designed to address the problem of small sample size and large number of features in biological data. Therefore, it is widely used on sequencing features. Here, we select this approach to facilitate the data mining of significant cell cycle genes.
The first step of MCFS is to randomly generate s feature subsets from the initial d features, each of which contains different m features. The samples that correspond to each subset are split into a training set and a test set in the ratio of 2 : 1, respectively. This division is performed t times, and each dataset is used to train a DT. Finally, a total of t × s DTs are constructed, and their performance is evaluated in the test set. A score called relative importance (RI) is assigned to feature g based on how well it performs in these classifiers and is given by the following formula:
(3) |
where wAcc represents the weighted accuracy, IG(ng(τ)) is the information gain (IG) of ng(τ) (a DT node n with the attribute g), (no. in ng(τ)) is the number of samples in ng(τ), and (no.in τ) is the number of samples in the tree root. u and v represent two fixed positive integers. All features are ranked in all features in the decreasing order of their RI values.
In this research, we utilize the MCFS program, which are obtained from http://www.ipipan.eu/staff/m.draminski/mcfs.html and run such program with the default parameters.
2.3.3. SHAP Values by LightGBM
SHAP (Shapley Additive Explanations), which is first proposed in 2017 by Lundberg and Lee, attempts to calculate the Shapley value of each feature of an instance, which estimates the contribution of the feature to the prediction of the instance [25, 26]. Given an instance x, its SHAP model is defined by the following equation:
(4) |
where z′ ∈ {0, 1}k is the coalition vector where 1 or 0 denotes that a feature is present or absent; k is the total number of features; g(z′) is the explanation model, which approximates the original model f(z) when z = hz(z′), where hz : {0, 1}k⟶ℝp maps z′ to a valid instance z, ∅0 represents the expected value of the original model f, ∅j is the SHAP value of the j-th feature, and zj′ ∈ {0, 1} denotes whether the j-th feature is present or not. Notably, x = z = hz(z′) when each element in z′ equals to 1. The SHAP values of x can be calculated by fitting a weighted linear model given a series of z′ and g(z′), and the coefficients of the linear model are taken as the SHAP values. Suppose that the SHAP value of j-th feature of i-th sample is ∅j(xi); if ∅j(xi) > 0, then the feature increases the prediction value; conversely, it means that the feature decreases the prediction value. The absolute value |∅j(xi)| indicates the contribution of the j-th feature towards the prediction of xi. Thus, the importance of the j-th feature in predicting all the instances can be calculated by the following equation:
(5) |
where n is the total number of the instances. The features in this research are ranked according to Ij. SHAP can be realized through any prediction model. LightGBM is a gradient boosting model that uses DTs as the base learner [21], which is rather effective and efficient in training and testing. Thus, LightGBM is adopted as the prediction model to calculate the SHAP values.
This study adopts the program of LightGBM obtained from https://lightgbm.readthedocs.io/en/latest/. Such program is executed using its default parameters.
2.4. Incremental Feature Selection
IFS is a strategy used to search for the optimal number of features [22]. It is widely used for feature selection because of its efficiency and simplicity. Previously, we have obtained some feature lists by using feature ranking algorithms, but the optimal subsets cannot be determined yet. We combine the results of the feature ranking algorithms with the IFS to obtain the optimal feature subsets for subsequent analysis. Given a feature list, several feature subsets are constructed, each of which contains some top features in the list. Then, a classifier is built on samples represented by features in each subset. All classifiers are further evaluated by tenfold cross-validation [27]. The classifier with best performance, measured by Matthew's correlation coefficient (MCC) [28–31] in this study, is picked up. Such classifier is called the optimal classifier and the feature subset used in this classifier is termed as the optimal feature set for this classifier.
2.5. Classification Algorithm
IFS requires supervised classification algorithms as a basis, so we select four efficient classification algorithms: RF [32], support vector machine (SVM) [33], k-nearest neighbor (KNN) [34], and DT [35]. These algorithms have wide applications [36–43]. They are briefly described as follows.
2.5.1. Random Forest
RF is an ensemble classification algorithm, which consists of several DTs. Each DT is built by randomly selecting features and samples. To make a classification, the voting method is used, where the final output is obtained by choosing the category with the highest votes. Here, we use RF from the Scikit-learn [44] package in Python. Default parameters are used to execute this package, where the number of DTs is 100.
2.5.2. Support Vector Machine
SVM is a classic machine learning algorithm with excellent performance and is of high popularity. It is often used to solve classification problems. The SVM process can be roughly divided into three parts: maximum interval, high-dimensional mapping, and kernel methods. The maximum interval refers to the distance that maximizes the data to the decision boundary, which is the core idea of SVM. High-dimensional mappings are the key to SVM that can be used in linear methods to solve nonlinear classification problems. The introduction of kernel methods allows SVMs to handle problems in a more diverse way to achieve higher efficiency. In this study, we use the SVM in the Scikit-learn [44] package. RBF function is set as the kernel of SVM.
2.5.3. k-Nearest Neighbor
The core idea of the KNN algorithm is that if the majority of the k most similar samples in the feature space of a sample belong to a certain class, then that sample also belongs to that class. This similarity is measured by calculating the distance between samples. Therefore, the calculation of the distance and the choice of k values are the focus of this algorithm. We do this by using the KNN in the Scikit-learn [44] package and setting the default parameters.
2.5.4. Decision Tree
As a machine learning algorithm with good interpretation, high training efficiency, and easy understanding, DTs are widely used in areas, such as classification and feature selection [35]. The DT recursively performs splitting and produces a tree structure that consists of nodes and directed edges. Moreover, the classification of an instance is made by sorting down the tree until reaching a leaf node. We use DT to generate a set of interpretable rules for subsequent analysis. Here, we use the Scikit-learn [44] package to perform DT using the CART algorithm with Gini coefficients as the information gain.
2.6. Performance Evaluation
The MCC is a relatively balanced indicator and can be used for cases where the sample size is unbalanced. The range of MCC is [−1, 1], where a value of 1 means that the predictions are exactly the same as the actual results, a value of 0 means that the predictions are like random predictions, and −1 means that the predictions are the opposite of the actual results. The MCC describes the strength of the correlation between the predicted and actual results. For multiclassification problems, the MCC can be calculated by the following formula [28]:
(6) |
where X represents the binary matrix (N × K, where N and K stand for the numbers of samples and classes, respectively) into which the predicted class of each sample is converted by one-hot encoding, Y represents another binary matrix (N × K) into which the true class of each sample is converted by one-hot encoding, and cov(X, Y) represents the covariance of two matrices. and represent the means of the k column of matrices X and Y, respectively. Xnk and Ynk are the elements in the n-th row and k-th column of the matrices X and Y, respectively.
In addition, the accuracy on each class (different cell cycle phases in this study) and overall accuracy (ACC) are also computed to give a full evaluation on different classifiers. The accuracy on one class is the ratio of correctly classified samples and all samples in this class, where ACC is the ratio of correctly classified samples and all samples.
2.7. Functional Enrichment Analysis
Through the IFS method, the optimal feature subsets for a classification algorithm can be obtained. Functional enrichment analysis is important as a means of unraveling the molecular mechanisms of biomedicine and is important for revealing other processes influenced by cell cycle-related genes. Here, we use R package clusterProfiler [45] to perform Gene Ontology (GO) and Kyoto Encyclopedia of Genes and Genomes (KEGG) pathway enrichment analyses.
3. Results
In this study, we mine cell cycle-related genes and rules for cell cycle classification through some feature selection methods and classification algorithms. The overall computational procedures are illustrated in Figure 1. The results of each step are described in detail below.
3.1. Results of Feature Selection Methods
First, Boruta is applied on single-cell RNA sequencing of human U2OS cells for feature filtering. A total of 788 gene features are retained and are displayed in Table S1. Then, these genes are analyzed by three feature ranking algorithms (MCFS, mRMR and SHAP by LightGBM) to generate feature lists according to their importance. These feature lists are also provided in Table S1.
3.2. Results of IFS Method
The three ordered feature lists produced by three feature ranking algorithms are fed into the IFS method with four classification algorithms (e.g., RF, SVM, KNN, and DT) one by one. From each feature list, all possible feature subsets are constructed with step interval of 1. A classifier is built on each feature subset with a given classification algorithm. All classifiers are assessed by tenfold cross-validation. The predicted results are provided in Table S2.
Of the feature list yielded by the mRMR method, the performance of four classification algorithms on all feature subsets is illustrated in four IFS curves, as shown in Figure 2, from which we can see that the highest MCC values for DT, KNN, RF, and SVM are 0.753, 0.803, 0.859, and 0.826, respectively. These MCC values are obtained by using top 158, 37, 195, and 124 features, respectively, in the list. Thus, these features comprise the optimal feature subset for four classification algorithms, and the optimal DT, KNN, RF, and SVM classifiers are set up with their corresponding optimal feature subset. The ACC values of these classifiers are 0.836, 0.869, 0.906, and 0.884, respectively, as listed in Table 1. Their performance on three classes is shown in Figure 3. Evidently, among all four optimal classifiers, the optimal RF classifier gives the best performance and the optimal DT classifier yields the lowest performance.
Table 1.
Feature ranking algorithms | Classification algorithm | Number of features | ACC | MCC |
---|---|---|---|---|
mRMR | Random forest | 195 | 0.906 | 0.859 |
Support vector machine | 124 | 0.884 | 0.826 | |
k-nearest neighbor | 37 | 0.869 | 0.803 | |
Decision tree | 158 | 0.836 | 0.753 | |
| ||||
MCFS | Random forest | 52 | 0.906 | 0.859 |
Support vector machine | 526 | 0.918 | 0.878 | |
k-nearest neighbor | 76 | 0.881 | 0.822 | |
Decision tree | 479 | 0.842 | 0.762 | |
| ||||
SHAP by LightGBM | Random forest | 87 | 0.917 | 0.875 |
Support vector machine | 222 | 0.917 | 0.875 | |
k-nearest neighbor | 18 | 0.866 | 0.800 | |
Decision tree | 103 | 0.856 | 0.784 |
As for the feature list produced by the MCFS method, we also plot an IFS curve for each classification algorithm, as illustrated in Figure 4. When top 479, 76, 52, and 526 features in the list are adopted, the DT, KNN, RF, and SVM provide the highest MCC values of 0.762, 0.822, 0.859, and 0.878. Accordingly, the optimal feature subset for each of four classification algorithms is determined, which consists of top 479, 76, 52, and 526 features, respectively, in the list. Furthermore, the optimal DT, KNN, RF, and SVM classifiers are built on their optimal feature subsets, respectively. The ACC values of these classifiers are listed in Table 1, and their performance on three classes is listed in Figure 3. The optimal SVM classifier produces the best performance, and the performance of the optimal DT classifier is much lower than other three classifiers.
For the last feature list generated by SHAP by LightGBM, the performance of four classification algorithms on different feature subsets is also summarized in four IFS curves, as shown in Figure 5. Four classification algorithms give the best performance with MCC values of 0.784, 0.800, 0.875, and 0.875, respectively, when top 103, 18, 87, and 222, respectively, features in the list are used. These features constitute the optimal feature subset for each classification algorithm, with which the optimal DT/KNN/RF/SVM classifier is built. Their detailed performance is shown in Table 1 and Figure 3. The optimal RF and SVM give equal performance and they are much superior to other two optimal classifiers. The optimal DT classifier again provides the lowest performance.
Among all optimal classifiers based on different classification algorithms and feature lists, the optimal SVM classifier obtained by using feature list generated by MCFS provided the highest MCC of 0.878. Such classifier can be a latent useful tool to identify cell cycle phases. On the other hand, according to Figures 2, 4, and 5 and Table 1, the optimal feature subsets always contain lots of features. They are almost useless for us to extract most essential features. In view of this, we try to find out one feasible feature subset for each feature list, on which one classifier can still provide satisfied performance. By observing IFS curves in Figures 2, 4, and 5, we can find that the IFS curve of RF always follows a sharp increasing trend at the beginning of the curve and the RF always provides better performance than other three classification algorithms at this stage. Thus, we determine the feasible feature subset according to the IFS curve of RF. By carefully checking the IFS curves of RF, we determine that the top 32 features in the list yielded by the mRMR method constitute the feasible feature subset for such list. On such subset, RF provides the MCC of 0.821, which is a little lower than that of the optimal RF/SVM classifier. As for the feature list yielded by MCFS method, top 21 features comprise the feasible feature subset, whereas the top 11 features constitute the feasible feature subset for the list yielded by SHAP by LightGBM. The RF classifiers on these feature subsets provide the MCC values of 0.823 and 0.851, respectively, which are also a little lower than those of the optimal RF/SVM classifiers. These feasible feature subsets can be seen in Table S3. As shown in Figure 6, a Venn diagram is plotted for these three feasible feature subsets. It can be observed that five features are included in all three subsets. Their corresponding genes are listed in Table 2. A detailed analysis has been conducted for these overlapping genes, which can be seen in Section 4.
Table 2.
Ensembl ID | Gene symbol | Description |
---|---|---|
ENSG00000140451 | PIF1 | PIF1 5′-to-3′ DNA helicase |
ENSG00000170312 | CDK1 | Cyclin-dependent kinase 1 |
ENSG00000175063 | UBE2C | Ubiquitin-conjugating enzyme E2 C |
ENSG00000189057 | FAM111B | FAM111 trypsin like peptidase B |
ENSG00000197061 | H4C3 | H4 clustered histone 3 |
3.3. Classification Rules
DT, as a white-box algorithm, has good interpretability, although it is generally not as good as other black-box algorithms in terms of overall model performance. The results in Section 3.2 further confirm this fact; that is, the optimal DT classifiers are always inferior to other optimal classifiers. However, it can provide more clues to uncover hidden information in the single-cell RNA sequencing data. In detail, owing to DT's unique single tree structure, we can extract the classification rules to obtain a quantitative representation of the features used for cell cycle classification.
Here, in IFS results on the feature lists generated by the mRMR, MCFS, and SHAP by LightGBM methods, the optimal DT classifiers use the top 158, 479, and 103 features, respectively. Therefore, we construct the DTs with these features and extract rules form these trees. 76, 69, and 76 classification rules are obtained, respectively, which can be seen in Table S4. The number of rules that distinguish each cell cycle phase is shown in Figure 7. Limits on the amount of gene expression are set in each rule, thereby revealing the importance of high or low gene expression in differentiating the cell cycle phase. The classification rules generated by three feature ranking methods are similar to some extent. A detailed discussion of these rules can be found in Section 4.
3.4. Functional Enrichment Analyses
For each feature list yielded by one feature ranking algorithm, the optimal feature subset that can provide the best performance for four classification algorithms is selected. According to Table 1, top 195, 526, and 222 features in the feature lists yielded by mRMR, MCFS, and SHAP by LightGBM are picked up. The clusterProfiler package is used to perform GO and KEGG enrichment analyses on above three optimal feature subsets. GO terms and KEGG pathway are filtered according to the condition of FDR < 0.05. Subsequently, the top 5 of each GO term and KEGG pathway are selected for visualization, which can be seen in Figure 8. Among these enrichment results, results like DNA replication activity and the p53 signaling pathway have been reported to be associated with the cell cycle. A detailed analysis of the enrichment results can be seen in Section 4.
4. Discussion
We use several advanced computational methods to identify the genes and rules for distinguishing cells from different cell cycle phases at the single-cell level. In the above, we identified the feasible feature set from each feature list, which make important contributions in classifiers and are considered potential cell cycle phase markers. These feasible feature sets consist of top 32, 21, and 11, respectively, features in the corresponding list. Then, we used the cell cycle-related gene sets in Seurat and Scran to screen all genes in the feasible feature sets that nearly 70% of the genes could be found in these datasets [14, 15]. This illustrates the accuracy of our results and implies a portion of potential cell cycle-related gene markers. Detailed analyses of the correlations between cell cycle and features that overlap in the three feature subsets or rules are provided below.
4.1. Features Found by All Three Feature Ranking Algorithms
A total of five genes are present in all three feature subsets, as listed in Table 2. These five genes are found to be qualitatively better for classifier performance in different feature filtering approaches. Therefore, these five genes are considered to be important for the classification of cell cycle phases. These genes have been reported in other studies as follows.
The first gene in the predicted list is CDK1 (ENSG00000170312), which encodes a cyclin-dependent kinase. CDK1 kinase coordinates the processes of mitosis, DNA replication, and transcription by binding to other cell cycle proteins [46]. The CDK1 plays a crucial role in regulating the cellular transition from G1 to S and from G2 to M [47]. The abnormal regulation of the cell cycle often leads to the development of cancer. As early as 2007, it was discovered that sustained activation of CDK1 causes cells to fail to exit mitosis normally, resulting in the appearance of abnormal cells that have been shown to be associated with the development of cancer [48]. In 2018, tumor cells with radioactive inhibition of CDK1 activity were found to have a weaker clone level, further demonstrating the potential of CDK1 in tumor therapy [49]. In addition, CDK1 drives phosphorylation of phosphorylation sites near protein nuclear localization signals, thereby assisting nuclear pore transport and completing nuclear proteome remodeling in the late M phase [50]. CDK1 not only broadens the approach to tumor therapy based on control of the cell cycle but also plays an important role in cell cycle development.
Apart from CDK1, FAM111B (ENSG00000189057) is also found in our prediction list, and it encodes a homologous serine protease. Notably, FAM111A appears as a homologous protein to FAM111B in both feature subsets. Previous studies have shown that protein obstacles exist on genomic DNA, and such protein obstacles will affect the replication fork advancement, causing DNA replication to stall [51]. FAM111A mitigates the effects of protein obstacles on replication forks, thereby ensuring proper DNA replication [51]. In addition, mutants of FAM111A and FAM111B exhibit the inhibition of chromosome-associated processes, which leads to the shutdown of DNA replication and transcription, impaired microtubule network integrity, and even cell death [52]. Moreover, mutations in FAM111B cause hereditary fibrous dermatosis combined with tendon contracture, myopathy, and pulmonary fibrosis, as well as hereditary pancreatic exocrine dysfunction, among other disorders [53, 54]. Our study suggests the important role of FAM111B and FAM111A in cell cycle classification, which is consistent with previous studies. Meanwhile, in the future, we should focus on the association between rare diseases caused by these two genes and the cell cycle.
The next identified gene is PIF1 (ENSG00000140451), which produces a DNA-dependent ATP-metabolizing enzyme that acts as a 5′ to 3′ DNA helicase. PIF1 plays a role in maintaining telomeres and assisting DNA replication in humans [55, 56]. In addition, PIF1 contributes to the excision of G-quadruplex structures, thus assisting in DNA damage repair [57]. There is a significantly high expression during the S phase of the cell cycle, especially when DNA is damaged.
H4C3 (ENSG00000197061) is a member of the histone H4 family, and its primary function is to aid DNA replication-dependent nucleosome assembly. Mutations of H4C3 have been reported to cause errors in the DNA replication process and DNA damage repair process, which will affect the cell cycle progression [58]. In addition, numerous studies have shown that posttranslational modifications of histone H4 are closely associated with cell cycle progression [59, 60]. This finding demonstrates the superiority of our approach, suggesting that future studies of genes associated with the cell cycle phases should be pursued at the multiomic level.
The last gene that ranked highly in all three feature ranking methods was UBE2C (ENSG00000175063), which encodes a member of the E2 ubiquitin-conjugating enzyme family. UBE2C promotes the degradation of various target proteins during cell cycle progression, including mitotic cyclins, as a component of the anaphase promoting complex/cyclosome (APC/C) [61, 62]. FOXM1 (Forkhead Box Protein M1) is a transcription factor that regulates the expression of genes related to G1/S, G2/M transition, and M phase progression, and UBE2C is one of the transcriptional targets of FOXM1 [63]. These studies further illustrate the important role of UBE2C in regulating the transition between cell cycle phases.
4.2. Highly Ranked Features Identified by Three Algorithms
The first identified gene is FBXO5, which encodes a protein that is a member of the F-box family. Cell cycle regulation relies on protein degradation by the ubiquitin-proteasome system, of which APC/C is a major ubiquitin ligase [64]. As early as 2005, it was found that FBXO5 acted as a cell cycle regulator that could regulate the timing of cell entry into the S phase by inhibiting APC/C [65]. In 2018, two transcriptional isoforms of FBXO5 were found to contribute to the migration and differentiation of human periodontal membrane stem cells (HPDLSCs), which provides a potential target for periodontal tissue regeneration [66]. This further illustrates the important role of FBXO5 in cell growth and development. Studies have also found that FBXO5 is associated with poor prognosis in ovarian cancer, prostate cancer, and hepatocellular carcinoma [67–69]. Reviewing previous studies, we can find that FBXO5 not only plays an important role in the cell cycle but also plays a key role in cancer development, which clarifies the association between the cell cycle and cancer. This finding also illustrates the superiority of our approach in discovering this potential connection.
TOP2A, another gene on both of the prediction lists, encodes a DNA topoisomerase, an enzyme required for superhelical DNA dehiscence that alters the topology of DNA during transcription. Previous studies have shown that the exercise of the normal function of TOP2A is essential for late G2 and M phase chromosome formation [70]. The treatment of TOP2A with conditional depletion in mammals revealed a longer duration of the cell cycle, which was attributed to the fact that TOP2A depletion led to impaired chromosome condensation and segregation, thereby resulting in the frequent failure of cell division [71]. While the above studies illustrate the key role of TOP2A in the G2/M transition, scientists have discovered that TOP2A also functions in other periods of the cell cycle as research continues. In 2016, scientists discovered that TOP2A plays a role in the recruitment of mitophagy in the S phase [72]. Phosphorylation-deficient TOP2A accelerates the recruitment of mitophagy in S phase, which leads to the premature segregation of mitotic DNA [72]. In recent years, increasing studies have found that TOP2A plays an important role in the development of cancer. One study found that TOP2A promotes the proliferation and migration of gallbladder cancer cells through the PI3K/Akt/mTOR pathway, suggesting that TOP2A is associated with the poor prognosis of patients [73]. Changes in DNA structure during the cell cycle are complex and diverse, and TOP2A alters the structure of DNA along with the potential function of many genes, thereby resulting in a range of cancer-associated functional loci. Our approach has superior performance in finding such genes associated with cell cycle and disease.
FHL2, four and a half LIM domain protein 2, is a protein that consists of only the LIM structural domain. Based on the functional diversity of LIM structural domains, FHL2 can interact with various proteins and thus play an important role in cell proliferation, differentiation, and signaling [74, 75]. Findings suggest that the interaction of FHL2 and iASPP inhibits apoptosis and promotes cell proliferation [76]. If FHL2 is knocked out, then it causes the cell cycle to stay in the G0/G1 phase, thereby inhibiting cell proliferation [76]. In addition, FHL2 can also interact directly with HIF-1alpha to inhibit transcriptional activity, suggesting that FHL2 is a negative regulator of HIF-1 activity [77]. The specificity of the FHL2 structure allows it to act as a transcriptional cofactor that links to various signaling pathways to transcriptional regulation. Interestingly, the expression level of FHL2 is also associated with the development of cancer [78]. FHL2 knockdown downregulated the expression of key proteins in the PI3K/AKT/mTOR signaling pathway, thereby promoting apoptosis and inhibiting the proliferation of cervical cancer cells [79]. This instance suggests that FHL2 may serve as a potential target for cancer therapy.
CDCA2 and CDCA5 encode two cell cycle proteins, both of which can interact with lectins during the cell cycle, thereby stabilizing the chromosome structure [80, 81]. CDCA5 was coexpressed with CDK1 in gastric cancer, thereby affecting the normal cell cycle transition and thus leading to the proliferation of gastric cancer cells [82]. CDCA5 and CDK1 were ranked as top-ranked genes that affect the cell cycle in our approach, indicating the potential role of our approach in revealing this coexpression relationship. In colorectal cancer, Feng et al. found that the upregulation of CDCA2 expression led to the upregulation of CCND1, which affected cell cycle progression and activated the PI3K/AKT pathway, leading to the proliferation of cancer cells [83]. Notably, the inhibition of CDCA2 and CDCA5 activities in lung and gastric adenocarcinoma, respectively, resulted in the downregulation of CCNE1 expression, thereby inhibiting cancer cell proliferation and blocking it in the G1 phase [84, 85]. As two proteins closely related to the cell cycle, they share a similar mechanism in regulating cell proliferation. The ability of our method to identify such genes with similar mechanisms further illustrates the superiority of our approach.
4.3. Functional Enrichment Analyses on Optimum Gene Features
Here, we find that mRMR, MCFS, and SHAP by LightGBM achieve optimal classification in the IFS method when the number of features is 195, 526, and 222, respectively. Therefore, we selected the 195, 526, and 222 genes in each ranked gene list for GO terms and KEGG pathway analysis and filtered enriched entries of interest based on the FDR < 0.05 threshold. The enrichment analysis results show that all GO terms are directly associated with the cell cycle. The most significantly enriched pathway for KEGG is the cell cycle, thereby confirming the reliability of our selection of these genes as a criterion for differentiating cells with various cell cycles. The detailed discussion on significant GO terms and KEGG pathways can be observed below.
Top GO terms and KEGG pathways are selected for analysis. We find that enrichment in biological processes (BP) is related to the separation of chromosomes and nucleus, such as GO:0098813, which refers to the biological process of nuclear chromosome segregation. In mitosis, the normal segregation of chromosomes is the basis for daughter cells to have a complete genome [86]. The main enrichment results of cellular component (CC) are chromosomes and nucleus, such as GO:0098687, which refers to the CC of the chromosomal region. The enrichment results of molecular function (MF) are mainly related to the activity and topology of DNA, such as GO:0017116, which refers to the MF of single-stranded DNA helicase activity. The central process of the cell cycle is the replication of the genome and its correct transmission to the daughter cells. The activity and topology of the DNA ensure that it initiates the DNA replication process with the correct structure in the S phase [87–89]. hsa04115, which refers to the p53 signaling pathway, appeared in our KEGG pathway enrichment results. Many studies in the past have shown that the activation of p53 leads to cell cycle arrest and apoptosis [90, 91]. Through the detailed analysis of GO and KEGG, we find that they are both linked to the cell cycle, thereby indicating the accuracy of our prediction method.
After verifying the reliability of genes selected by computational methods in differentiating the cell cycle, we are more interested in determining the existence of genes that regulate the cell cycle while participating in other processes, such as disease development and apoptosis because this has the potential to instruct the cell to influence these processes in a way that regulates the cell cycle. In the KEGG pathway analysis, we find that the Fanconi anemia pathway is significantly enriched. Fanconi anemia is a rare genetic disease characterized by genomic instability and cellular sensitivity to DNA cross-linking agents [92]. In addition, when the Fanconi anemia pathway is damaged, it causes the S phase DNA interstrand cross-link repair process to fail to proceed properly [92, 93]. This finding suggests the interaction between the development of disease and cell cycle. Our study provides several new cell cycle-related genes that may be involved in disease progression. In the future, we should pay more attention to these other processes mediated by cell cycle genes.
4.4. Rules for Quantitative Cell Cycle Classification
Apart from the qualitative analysis of genes described above, we also establish a series of rules for cells in each specific cell cycle. If a classification rule is applicable in at least two DT models, then we consider such rule to be extremely important for its role, which is analyzed in detail as follows.
The first decision rule is aimed at identifying the cells in the G1 phase from the three other phases. This purpose is specifically indicated by the low expression of CDK1, H4C3, CDC45, and E2F2 and the high expression of TXNL1. CDK1 gradually began to accumulate after G1 and is inactivated upon exit from mitosis, thereby maintaining a low expression in G1 [48]. H4C3 belongs to the histone H4 family, and its main function relates to its involvement in DNA replication-dependent nucleosome assembly [94]. Histone synthesis occurs mainly in the S phase. Thus, the expression level remains low in the G1 phase. CDC45 and E2F2 have been the key genes from the G1 to S phase. The high expression of CDC45 leads to the activation of S phase initiation and induces an early entry from G1 to S phase [95]. The binding of E2F2 to its inhibitory miRNA decreases the level of E2F2 expression, thereby blocking cell division in the G1 phase [96, 97]. This finding suggests that high expressions of CDC45 and E2F2 cause the cell cycle to advance from the G1 to the S phase. The requirement for low expression levels of these two genes in our rule to distinguish G1 cells is consistent with the above pattern and demonstrates the reliability of our rule. In previous studies, high levels of TXNL1 expression would enhance the action of transcriptional repressors by binding to the transcription factor B-Myb [98]. This finding suggests that the high expression level of TXNL1 leads to the failure of normal transition to the G1 phase, which is consistent with our classification rules.
The second rule is mainly related to distinguishing G2/M phase cells. This rule is demonstrated by the high expression of CDK1, PIF1, CENPF, and SRRM2 and the low expression of CCNE1, CCNE2, ZWINT, and ARPC1B. As discussed previously, CDK1 and H4C3 play important roles in the G2 to M phase transition process and S to G2 phase histone synthesis and nucleosome assembly, respectively. Therefore, these two genes are abundantly expressed in cells during this period. The expression of PIF1 is regulated by the cell cycle [99]. Its expression in cells in the G1 phase is low and rises as the cell cycle progresses, peaking at the end of the S and G2 phases [99]. Similar to PIF1, CENPF expression accumulates at the S phase and peaks at G2 and M phases [100]. SRRM2 has been reported to form complexes with other proteins and contribute to chromosome segregation and genome stabilization by ensuring the splicing of specific pre-mRNAs [101]. Thus, high expression of SRRM2 promotes better binding to other proteins to form complexes, thereby assisting in M phase functions. These genes with high expression levels all exhibit cell cycle-specific expression properties, which are useful for identifying cells that are in a specific cell cycle. The proteins encoded by CCNE1 and CCNE2 are collectively known as cyclin E [102]. They facilitate the transition from the G1 to S phase by binding to CDK2 kinase [102]. CCNE1 exhibits cell cycle-specific expression. It begins to accumulate during the G1 to S phase transition and begins to degrade upon entry into the S phase [103]. In addition, high expression of CCNE1 and CCNE2 leads to genomic instability, which affects the normal progression of the M phase [104]. This finding is consistent with the restriction on the expression of these two genes in our rules to distinguish normal G2/M phase cells [105, 106]. ZWINT affects the meiotic process by recruiting kinetochores and assisting in the segregation of homologous chromosomes [107]. ARPC1B is an activator and substrate of Aurora A, which regulates centrosome stability [108]. In addition, small interfering RNA-mediated depletion of ARPC1B inhibited G2-M phase cell cycle progression [108].
The last rule is associated with cells in the S phase. It is specifically indicated by the high expression of CDK1, MCM5, H4C3, BRCA1, and PKMYT1 and the low expression of PIF1, ANKRD20A8P, AXL, and TNFAIP8L1. As introduced above, CDK1 begins to accumulate after G1 and plays a role in the G1 to S phase transition. Thus, CDK1 has high expression in the S phase. H4C3 is also consistent with the previously discussed results. It mainly encodes histones, and the synthesis of histones occurs mainly in the S phase. Hence, it is highly expressed in this period. MCM5 has been shown to regulate the cell cycle by assisting in DNA replication and DNA damage repair [109, 110]. High MCM5 expression regulates the DNA damage checkpoint [109, 110]. This instance suggests that high MCM5 expression helps S phase DNA perform normal synthetic functions and repair damaged DNA. Mutations in BRCA1 have been widely associated with the development of breast cancer [111]. In addition, BRCA1 itself has been associated with gene regulation. It can induce GADD45, a p53-regulated and stress-inducible gene that plays an important role in responding to DNA damage [112]. This finding shows that high expression of BRCA1 ensures that DNA can be repaired in a timely manner when it is damaged, thereby allowing DNA to be replicated in a correct and orderly manner. PKMYT1 knockdown increased the expression of DNA damage markers [113]. In addition, PKMYT1 overexpression is found in Kaposi's sarcoma-associated herpesvirus-infected S phase cells, indicating its potential role in S phase transition [114]. Among these low expressed genes, PIF1 is cycle-specific in its expression, as previously described, and the expression begins to accumulate in the S phase. Thus, the expression is not excessive. Knockdown of TNFAIP8L1 and its homologs resulted in a cell cycle stuck in the S phase, suggesting that its low expression caused the cells to show more S phase characteristics [115]. In previous studies, the association of ANKRD20A8P and AXL with the cell cycle is not clearly indicated, so they may serve as potential targets for indicating the cell cycle.
5. Conclusions
In the present study, we apply advanced and widely used computational methods to single-cell RNA sequencing data to explore additional cell cycle information. In summary, our study has identified a series of potential cell cycle-related genes that can serve as novel cell cycle markers and contribute to exploring the molecular mechanisms of cell cycle regulation further. In addition, we present an optimal classifier for cell cycle prediction, which has been trained with a large amount of single-cell data to achieve excellent classification performance. Finally, the quantitative decision rules in the classification model provide direct clues for distinguishing cells in different phases.
Acknowledgments
This research was funded by the Strategic Priority Research Program of Chinese Academy of Sciences (XDA26040304 and XDB38050200), the National Key R&D Program of China (2018YFC0910403), and the Fund of the Key Laboratory of Tissue Microenvironment and Tumor of Chinese Academy of Sciences (202002).
Contributor Information
Tao Huang, Email: tohuangtao@126.com.
Yu-dong Cai, Email: cai_yud@126.com.
Data Availability
The original data used to support the findings of this study are available at Gene Expression Omnibus database (https://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE146773).
Conflicts of Interest
The authors declare that there is no conflict of interest regarding the publication of this paper.
Authors' Contributions
FeiMing Huang and Lei Chen contributed equally to this work.
Supplementary Materials
References
- 1.Liu L., Michowski W., Kolodziejczyk A., Sicinski P. The cell cycle in stem cell proliferation, pluripotency and differentiation. Nature Cell Biology . 2019;21(9):1060–1067. doi: 10.1038/s41556-019-0384-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 2.McInerny C. J. Cell cycle regulated gene expression in yeasts. Advances in Genetics . 2011;73:51–85. doi: 10.1016/B978-0-12-380860-8.00002-1. [DOI] [PubMed] [Google Scholar]
- 3.Liu P., Begley M., Michowski W., et al. Cell-cycle-regulated activation of Akt kinase by phosphorylation at its carboxyl terminus. Nature . 2014;508(7497):541–545. doi: 10.1038/nature13079. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.Williams G. H., Stoeber K. The cell cycle and cancer. The Journal of Pathology . 2012;226(2):352–364. doi: 10.1002/path.3022. [DOI] [PubMed] [Google Scholar]
- 5.Ingham M., Schwartz G. K. Cell-cycle therapeutics come of age. Journal of Clinical Oncology . 2017;35(25):2949–2959. doi: 10.1200/JCO.2016.69.0032. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6.Potten C. S., Wichmann H. E., Dobek K., et al. Cell kinetic studies in the epidermis of mouse. III. The percent labelled mitosis (PLM) technique. Cell and Tissue Kinetics . 1985;18(1):59–70. doi: 10.1111/j.1365-2184.1985.tb00632.x. [DOI] [PubMed] [Google Scholar]
- 7.Darzynkiewicz Z., Bedner E., Smolewski P. Flow cytometry in analysis of cell cycle and apoptosis. Seminars in Hematology . 2001;38(2):179–193. doi: 10.1016/S0037-1963(01)90051-4. [DOI] [PubMed] [Google Scholar]
- 8.Sakaue-Sawano A., Kurokawa H., Morimura T., et al. Visualizing spatiotemporal dynamics of multicellular cell-cycle progression. Cell . 2008;132(3):487–498. doi: 10.1016/j.cell.2007.12.033. [DOI] [PubMed] [Google Scholar]
- 9.Dabydeen S. A., Desai A., Sahoo D. Unbiased Boolean analysis of public gene expression data for cell cycle gene identification. Molecular Biology of the Cell . 2019;30(14):1770–1779. doi: 10.1091/mbc.E19-01-0013. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Qiu P., Wang Z. J., Liu K. J. Polynomial model approach for resynchronization analysis of cell-cycle gene expression data. Bioinformatics . 2006;22(8):959–966. doi: 10.1093/bioinformatics/btl017. [DOI] [PubMed] [Google Scholar]
- 11.Liu C., Cui P., Huang T. Identification of cell cycle-regulated genes by convolutional neural network. Combinatorial Chemistry & High Throughput Screening . 2017;20(7):603–611. doi: 10.2174/1386207320666170417144937. [DOI] [PubMed] [Google Scholar]
- 12.Cui P., Zhong T., Wang Z., et al. Identification of human circadian genes based on time course gene expression profiles by using a deep learning method. Biochimica et Biophysica Acta (BBA) - Molecular Basis of Disease . 2018;1864(6):2274–2283. doi: 10.1016/j.bbadis.2017.12.004. [DOI] [PubMed] [Google Scholar]
- 13.Liu J., Fan Z., Zhao W., Zhou X. Machine intelligence in single-cell data analysis: advances and new challenges. Frontiers in Genetics . 2021;12, article 655536 doi: 10.3389/fgene.2021.655536. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Hao Y., Hao S., Andersen-Nissen E., et al. Integrated analysis of multimodal single-cell data. Cell . 2021;184(13):3573–3587.e29. doi: 10.1016/j.cell.2021.04.048. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Lun A. T., McCarthy D. J., Marioni J. C. A step-by-step workflow for low-level analysis of single-cell RNA-seq data with Bioconductor. F1000Research . 2016;5:p. 2122. doi: 10.12688/f1000research.9501.1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Grün D., Lyubimova A., Kester L., et al. Single-cell messenger RNA sequencing reveals rare intestinal cell types. Nature . 2015;525(7568):251–255. doi: 10.1038/nature14966. [DOI] [PubMed] [Google Scholar]
- 17.Anafi R. C., Francey L. J., Hogenesch J. B., Kim J. CYCLOPS reveals human transcriptional rhythms in health and disease. Proceedings of the National Academy of Sciences of the United States of America . 2017;114(20):5312–5317. doi: 10.1073/pnas.1619320114. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 18.Liang S., Wang F., Han J., Chen K. Latent periodic process inference from single-cell RNA-seq data. Nature Communications . 2020;11(1):p. 1441. doi: 10.1038/s41467-020-15295-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19.Peng H., Fulmi L., Ding C. Feature selection based on mutual information criteria of max-dependency, max-relevance, and min-redundancy. EEE Transactions on Pattern Analysis and Machine Intelligence . 2005;27(8):1226–1238. doi: 10.1109/TPAMI.2005.159. [DOI] [PubMed] [Google Scholar]
- 20.Draminski M., Rada-Iglesias A., Enroth S., Wadelius C., Koronacki J., Komorowski J. Monte Carlo feature selection for supervised classification. Bioinformatics . 2008;24(1):110–117. doi: 10.1093/bioinformatics/btm486. [DOI] [PubMed] [Google Scholar]
- 21.Ke G., Meng Q., Finley T., et al. Advances in Neural Information Processing Systems 30 (NIPS 2017) Curran Associates Inc.; 2017. LightGBM: a highly efficient gradient boosting decision tree. [Google Scholar]
- 22.Liu H. A., Setiono R. Incremental feature selection. Applied Intelligence . 1998;9(3):217–230. doi: 10.1023/A:1008363719778. [DOI] [Google Scholar]
- 23.Mahdessian D., Cesnik A. J., Gnann C., et al. Spatiotemporal dissection of the cell cycle with single-cell proteogenomics. Nature . 2021;590(7847):649–654. doi: 10.1038/s41586-021-03232-9. [DOI] [PubMed] [Google Scholar]
- 24.Kursa M. B., Rudnicki W. R. Feature selection with the Boruta package. Journal of Statistical Software . 2010;36(11):1–13. doi: 10.18637/jss.v036.i11. [DOI] [Google Scholar]
- 25.Lundberg S. M., Erion G., Chen H., et al. From local explanations to global understanding with explainable AI for trees. Nature Machine Intelligence . 2020;2(1):56–67. doi: 10.1038/s42256-019-0138-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 26.Lundberg S., Lee S. I. Nips . Curran Associates Inc.; 2017. A unified approach to interpreting model predictions. [Google Scholar]
- 27.Kohavi R. A study of cross-validation and bootstrap for accuracy estimation and model selection. Proceedings of the 14th international joint conference on Artificial intelligence - Volume 2; 1995; Montreal, Quebec, Canada. pp. 1137–1143. [Google Scholar]
- 28.Gorodkin J. Comparing two K-category assignments by a K-category correlation coefficient. Computational Biology and Chemistry . 2004;28(5-6):367–374. doi: 10.1016/j.compbiolchem.2004.09.006. [DOI] [PubMed] [Google Scholar]
- 29.Matthews B. W. Comparison of the predicted and observed secondary structure of T4 phage lysozyme. Biochimica et Biophysica Acta . 1975;405(2):442–451. doi: 10.1016/0005-2795(75)90109-9. [DOI] [PubMed] [Google Scholar]
- 30.Liu H., Hu B., Chen L., Lu L. Identifying protein subcellular location with embedding features learned from networks. Current Proteomics . 2021;18(5):646–660. doi: 10.2174/1570164617999201124142950. [DOI] [Google Scholar]
- 31.Ding S., Wang D., Zhou X., et al. Predicting heart cell types by using transcriptome profiles and a machine learning method. Life . 2022;12(2):p. 228. doi: 10.3390/life12020228. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 32.Breiman L. Random forests. Machine Learning . 2001;45(1):5–32. doi: 10.1023/A:1010933404324. [DOI] [Google Scholar]
- 33.Cortes C., Vapnik V. Support-vector networks. Machine Learning . 1995;20(3):273–297. doi: 10.1007/BF00994018. [DOI] [Google Scholar]
- 34.Cover T., Hart P. Nearest neighbor pattern classification. IEEE Transactions on Information Theory . 1967;13(1):21–27. doi: 10.1109/TIT.1967.1053964. [DOI] [Google Scholar]
- 35.Safavian S. R., Landgrebe D. A survey of decision tree classifier methodology. IEEE Transactions on Systems, Man, and Cybernetics . 1991;21(3):660–674. doi: 10.1109/21.97458. [DOI] [Google Scholar]
- 36.Zhou X., Ding S., Wang D., et al. Identification of cell markers and their expression patterns in skin based on single-cell RNA-sequencing profiles. Life . 2022;12(4):p. 550. doi: 10.3390/life12040550. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 37.Chen L., Li Z. D., Zhang S. Q., Zhang Y.-H., Huang T., Cai Y.-D. Predicting RNA 5-methylcytosine sites by using essential sequence features and distributions. BioMed Research International . 2022;2022:11. doi: 10.1155/2022/4035462.4035462 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 38.Yang Y., Chen L. Identification of drug–disease associations by using multiple drug and disease networks. Current Bioinformatics . 2022;17(1):48–59. doi: 10.2174/1574893616666210825115406. [DOI] [Google Scholar]
- 39.Chen W., Chen L., Dai Q. iMPT-FDNPL: identification of membrane protein types with functional domains and a natural language processing approach. Computational and Mathematical Methods in Medicine . 2021;2021:10. doi: 10.1155/2021/7681497.7681497 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 40.Li X., Lu L., Chen L. Identification of protein functions in mouse with a label space partition method. Mathematical Biosciences and Engineering . 2022;19(4):3820–3842. doi: 10.3934/mbe.2022176. [DOI] [PubMed] [Google Scholar]
- 41.Sang X., Xiao W., Zheng H., Yang Y., Liu T. HMMPred: accurate prediction of DNA-binding proteins based on HMM profiles and XGBoost feature selection. Computational and Mathematical Methods in Medicine . 2020;2020:10. doi: 10.1155/2020/1384749.1384749 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 42.Chen L., Li J., Chang M. Cancer diagnosis and disease gene identification via statistical machine learning. Current Bioinformatics . 2020;15(9):956–962. doi: 10.2174/1574893615666200207094947. [DOI] [Google Scholar]
- 43.Wu Z., Chen L. Similarity-based method with multiple-feature sampling for predicting drug side effects. Computational and Mathematical Methods in Medicine . 2022;2022:13. doi: 10.1155/2022/9547317.9547317 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 44.Pedregosa F., Varoquaux G., Gramfort A., et al. Scikit-learn: machine learning in python. Journal of Machine Learning Research . 2011;12:2825–2830. [Google Scholar]
- 45.Wu T., Hu E., Xu S., et al. clusterProfiler 4.0: a universal enrichment tool for interpreting omics data. Innovations . 2021;2(3, article 100141) doi: 10.1016/j.xinn.2021.100141. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 46.Malumbres M., Harlow E., Hunt T., et al. Cyclin-dependent kinases: a family portrait. Nature Cell Biology . 2009;11(11):1275–1276. doi: 10.1038/ncb1109-1275. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 47.Malumbres M., Barbacid M. Cell cycle, CDKs and cancer: a changing paradigm. Nature Reviews Cancer . 2009;9(3):153–166. doi: 10.1038/nrc2602. [DOI] [PubMed] [Google Scholar]
- 48.Perez de Castro I., de Carcer G., Malumbres M. A census of mitotic cancer genes: new insights into tumor cell biology and cancer therapy. Carcinogenesis . 2007;28(5):899–912. doi: 10.1093/carcin/bgm019. [DOI] [PubMed] [Google Scholar]
- 49.Li M., He F., Zhang Z., Xiang Z., Hu D. CDK1 serves as a potential prognostic biomarker and target for lung cancer. The Journal of International Medical Research . 2020;48(2) doi: 10.1177/0300060519897508. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 50.Róna G., Borsos M., Ellis J. J., et al. Dynamics of re-constitution of the human nuclear proteome after cell division is regulated by NLS-adjacent phosphorylation. Cell Cycle . 2014;13(22):3551–3564. doi: 10.4161/15384101.2014.960740. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 51.Kojima Y., Machida Y., Palani S., et al. FAM111A protects replication forks from protein obstacles via its trypsin-like domain. Nature Communications . 2020;11(1):p. 1318. doi: 10.1038/s41467-020-15170-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 52.Hoffmann S., Pentakota S., Mund A., et al. FAM111 protease activity undermines cellular fitness and is amplified by gain-of-function mutations in human disease. EMBO Reports . 2020;21(10, article e50662) doi: 10.15252/embr.202050662. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 53.Mercier S., Küry S., Shaboodien G., et al. Mutations in FAM111B cause hereditary fibrosing poikiloderma with tendon contracture, myopathy, and pulmonary fibrosis. American Journal of Human Genetics . 2013;93(6):1100–1107. doi: 10.1016/j.ajhg.2013.10.013. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 54.Seo A., Walsh T., Lee M. K., et al. FAM111B mutation is associated with inherited exocrine pancreatic dysfunction. Pancreas . 2016;45(6):858–862. doi: 10.1097/MPA.0000000000000529. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 55.Gagou M. E., Ganesh A., Phear G., et al. Human PIF1 helicase supports DNA replication and cell growth under oncogenic-stress. Oncotarget . 2014;5(22):11381–11398. doi: 10.18632/oncotarget.2501. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 56.Gagou M. E., Ganesh A., Thompson R., Phear G., Sanders C., Meuth M. Suppression of apoptosis by PIF1 helicase in human tumor cells. Cancer Research . 2011;71(14):4998–5008. doi: 10.1158/0008-5472.CAN-10-4404. [DOI] [PubMed] [Google Scholar]
- 57.Jimeno S., Camarillo R., Mejías-Navarro F., et al. The helicase PIF1 facilitates resection over sequences prone to forming G4 structures. Cell Reports . 2018;24(12):3262–3273.e4. doi: 10.1016/j.celrep.2018.08.047. [DOI] [PubMed] [Google Scholar]
- 58.Tessadori F., Study D. D. D., Giltay J. C., et al. Germline mutations affecting the histone H4 core cause a developmental syndrome by altering DNA damage response and cell cycle control. Nature Genetics . 2017;49(11):1642–1646. doi: 10.1038/ng.3956. [DOI] [PubMed] [Google Scholar]
- 59.Pesavento J. J., Yang H., Kelleher N. L., Mizzen C. A. Certain and progressive methylation of histone H4 at lysine 20 during the cell cycle. Molecular and Cellular Biology . 2008;28(1):468–486. doi: 10.1128/MCB.01517-07. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 60.Jiang T., Hoover M. E., Holt M. V., Freitas M. A., Marshall A. G., Young N. L. Middle-down characterization of the cell cycle dependence of histone H4 posttranslational modifications and proteoforms. Proteomics . 2018;18(11, article e1700442) doi: 10.1002/pmic.201700442. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 61.Stegmeier F., Rape M., Draviam V. M., et al. Anaphase initiation is regulated by antagonistic ubiquitination and deubiquitination activities. Nature . 2007;446(7138):876–881. doi: 10.1038/nature05694. [DOI] [PubMed] [Google Scholar]
- 62.Townsley F. M., Aristarkhov A., Beck S., Hershko A., Ruderman J. V. Dominant-negative cyclin-selective ubiquitin carrier protein E2-C/UbcH10 blocks cells in metaphase. Proceedings of the National Academy of Sciences of the United States of America . 1997;94(6):2362–2367. doi: 10.1073/pnas.94.6.2362. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 63.Nicolau-Neto P., Palumbo A., de Martino M., et al. UBE2C is a transcriptional target of the cell cycle regulator FOXM1. Genes . 2018;9(4):p. 188. doi: 10.3390/genes9040188. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 64.Nakayama K. I., Nakayama K. Regulation of the cell cycle by SCF-type ubiquitin ligases. Seminars in Cell & Developmental Biology . 2005;16(3):323–333. doi: 10.1016/j.semcdb.2005.02.010. [DOI] [PubMed] [Google Scholar]
- 65.Hsu J. Y., Reimann J. D. R., Sørensen C. S., Lukas J., Jackson P. K. E2F-dependent accumulation of hEmi1 regulates S phase entry by inhibiting APCCdh1. Nature Cell Biology . 2002;4(5):358–366. doi: 10.1038/ncb785. [DOI] [PubMed] [Google Scholar]
- 66.Liu L., Liu K., Yan Y., Chu Z., Tang Y., Tang C. Two transcripts of FBXO5 promote migration and osteogenic differentiation of human periodontal ligament mesenchymal stem cells. BioMed Research International . 2018;2018:12. doi: 10.1155/2018/7849294.7849294 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 67.Min K. W., Park M. H., Hong S. R., et al. Clear cell carcinomas of the ovary. International Journal of Gynecological Pathology . 2013;32(1):3–14. doi: 10.1097/PGP.0b013e31825554e9. [DOI] [PubMed] [Google Scholar]
- 68.Yang G., Ayala G., de Marzo A., et al. Elevated Skp2 protein expression in human prostate cancer: association with loss of the cyclin-dependent kinase inhibitor p27 and PTEN and with reduced recurrence-free survival. Clinical Cancer Research . 2002;8(11):3419–3426. [PubMed] [Google Scholar]
- 69.Zhao Y., Tang Q., Ni R., et al. Early mitotic inhibitor-1, an anaphase-promoting complex/cyclosome inhibitor, can control tumor cell proliferation in hepatocellular carcinoma: correlation with Skp2 stability and degradation of p27Kip1. Human Pathology . 2013;44(3):365–373. doi: 10.1016/j.humpath.2012.03.030. [DOI] [PubMed] [Google Scholar]
- 70.Farr C. J., Antoniou-Kourounioti M., Mimmack M. L., Volkov A., Porter A. C. G. The α isoform of topoisomerase II is required for hypercompaction of mitotic chromosomes in human cells. Nucleic Acids Research . 2014;42(7):4414–4426. doi: 10.1093/nar/gku076. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 71.Gonzalez R. E., Lim C. U., Cole K., et al. Effects of conditional depletion of topoisomerase II on cell cycle progression in mammalian cells. Cell Cycle . 2011;10(20):3505–3514. doi: 10.4161/cc.10.20.17778. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 72.Wu K. Z., Wang G. N., Fitzgerald J., et al. DDK dependent regulation of TOP2A at centromeres revealed by a chemical genetics approach. Nucleic Acids Research . 2016;44(18):8786–8798. doi: 10.1093/nar/gkw626. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 73.Lyu W. J., Shu Y. J., Liu Y. B., Dong P. Topoisomerase II alpha promotes gallbladder cancer proliferation and metastasis through activating phosphatidylinositol 3-kinase/protein kinase B/mammalian target of rapamycin signaling pathway. Chinese Medical Journal . 2020;133(19):2321–2329. doi: 10.1097/CM9.0000000000001075. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 74.Wang Q., Wang X., Tian X., Tang R., Xu X. Four and a half LIM domains 2 contributes to the development of human tongue squamous cell carcinoma. Journal of Molecular Histology . 2016;47(2):105–116. doi: 10.1007/s10735-016-9654-7. [DOI] [PubMed] [Google Scholar]
- 75.Wei Y., Renard C. A., Labalette C., et al. Identification of the LIM protein FHL2 as a coactivator of β-catenin. The Journal of Biological Chemistry . 2003;278(7):5188–5194. doi: 10.1074/jbc.M207216200. [DOI] [PubMed] [Google Scholar]
- 76.Lu W., Yu T., Liu S., et al. FHL2 interacts with iASPP and impacts the biological functions of leukemia cells. Oncotarget . 2017;8(25):40885–40895. doi: 10.18632/oncotarget.16617. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 77.Hubbi M. E., Gilkes D. M., Baek J. H., Semenza G. L. Four-and-a-half LIM domain proteins inhibit transactivation by hypoxia-inducible factor 1. The Journal of Biological Chemistry . 2012;287(9):6139–6149. doi: 10.1074/jbc.M111.278630. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 78.Cao C. Y., Mok S. W. F., Cheng V. W. S., Tsui S. K. W. The FHL2 regulation in the transcriptional circuitry of human cancers. Gene . 2015;572(1):1–7. doi: 10.1016/j.gene.2015.07.043. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 79.Jin X., Jiao X., Jiao J., Zhang T., Cui B. Increased expression of FHL2 promotes tumorigenesis in cervical cancer and is correlated with poor prognosis. Gene . 2018;669:99–106. doi: 10.1016/j.gene.2018.05.087. [DOI] [PubMed] [Google Scholar]
- 80.Tan J., Qiu K., Li M., Liang Y. Double-negative feedback loop between long non-coding RNA TUG1 and miR-145 promotes epithelial to mesenchymal transition and radioresistance in human bladder cancer cells. FEBS Lett . 2015;589(20, Part B):3175–3181. doi: 10.1016/j.febslet.2015.08.020. [DOI] [PubMed] [Google Scholar]
- 81.Zhang N., Pati D. Sororin is a master regulator of sister chromatid cohesion and separation. Cell Cycle . 2012;11(11):2073–2083. doi: 10.4161/cc.20241. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 82.Huang Z., Zhang S., du J., et al. Cyclin-dependent kinase 1 (CDK1) is co-expressed with CDCA5: their functions in gastric cancer cell line MGC-803. Medical Science Monitor . 2020;26, article e923664 doi: 10.12659/MSM.923664. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 83.Feng Y., Qian W., Zhang Y., et al. CDCA2 promotes the proliferation of colorectal cancer cells by activating the AKT/CCND1 pathway in vitro and in vivo. BMC Cancer . 2019;19(1):p. 576. doi: 10.1186/s12885-019-5793-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 84.Shi R., Zhang C., Wu Y., et al. CDCA2 promotes lung adenocarcinoma cell proliferation and predicts poor survival in lung adenocarcinoma patients. Oncotarget . 2017;8(12):19768–19779. doi: 10.18632/oncotarget.15519. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 85.Zhang Z., Shen M., Zhou G. Upregulation of CDCA5 promotes gastric cancer malignant progression via influencing cyclin E1. Biochemical and Biophysical Research Communications . 2018;496(2):482–489. doi: 10.1016/j.bbrc.2018.01.046. [DOI] [PubMed] [Google Scholar]
- 86.Batty P., Gerlich D. W. Mitotic chromosome mechanics: how cells segregate their genome. Trends in Cell Biology . 2019;29(9):717–726. doi: 10.1016/j.tcb.2019.05.007. [DOI] [PubMed] [Google Scholar]
- 87.Hustedt N., Durocher D. The control of DNA repair by the cell cycle. Nature Cell Biology . 2016;19(1):1–9. doi: 10.1038/ncb3452. [DOI] [PubMed] [Google Scholar]
- 88.Lee J. H., Berger J. M. Cell cycle-dependent control and roles of DNA topoisomerase II. Genes (Basel) . 2019;10(11):p. 859. doi: 10.3390/genes10110859. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 89.Lemmens B., Lindqvist A. DNA replication and mitotic entry: a brake model for cell cycle progression. The Journal of Cell Biology . 2019;218(12):3892–3902. doi: 10.1083/jcb.201909032. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 90.Chen J. The cell-cycle arrest and apoptotic functions of p53 in tumor initiation and progression. Cold Spring Harbor Perspectives in Medicine . 2016;6(3, article a026104) doi: 10.1101/cshperspect.a026104. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 91.Wang X., Simpson E. R., Brown K. A. p53: protection against tumor growth beyond effects on cell cycle and apoptosis. Cancer Research . 2015;75(23):5001–5007. doi: 10.1158/0008-5472.CAN-15-0563. [DOI] [PubMed] [Google Scholar]
- 92.Knipscheer P., Räschle M., Smogorzewska A., et al. The Fanconi anemia pathway promotes replication-dependent DNA interstrand cross-link repair. Science . 2009;326(5960):1698–1701. doi: 10.1126/science.1182372. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 93.Yao C. J., du W., Zhang Q., Zhang F., Zeng F., Chen F. P. Fanconi anemia pathway--the way of DNA interstrand cross-link repair. Pharmazie . 2013;68(1):5–11. [PubMed] [Google Scholar]
- 94.Tagami H., Ray-Gallet D., Almouzni G., Nakatani Y. Histone H3.1 and H3.3 complexes mediate nucleosome assembly pathways dependent or independent of DNA synthesis. Cell . 2004;116(1):51–61. doi: 10.1016/S0092-8674(03)01064-X. [DOI] [PubMed] [Google Scholar]
- 95.Köhler C., Koalick D., Fabricius A., et al. Cdc45 is limiting for replication initiation in humans. Cell Cycle . 2016;15(7):974–985. doi: 10.1080/15384101.2016.1152424. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 96.Le M. T. N., Xie H., Zhou B., et al. MicroRNA-125b promotes neuronal differentiation in human cells by repressing multiple targets. Molecular and Cellular Biology . 2009;29(19):5290–5305. doi: 10.1128/MCB.01694-08. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 97.Wu N., Xiao L., Zhao X., et al. miR-125b regulates the proliferation of glioblastoma stem cells by targeting E2F2. FEBS Letters . 2012;586(21):3831–3839. doi: 10.1016/j.febslet.2012.08.023. [DOI] [PubMed] [Google Scholar]
- 98.Kim K. Y., Lee J. W., Park M. S., Jung M. H., Jeon G. A., Nam M. J. Expression of a thioredoxin-related protein-1 is induced by prostaglandin E2. International Journal of Cancer . 2006;118(7):1670–1679. doi: 10.1002/ijc.21572. [DOI] [PubMed] [Google Scholar]
- 99.Mateyak M. K., Zakian V. A. Human PIF helicase is cell cycle regulated and associates with telomerase. Cell Cycle . 2006;5(23):2796–2804. doi: 10.4161/cc.5.23.3524. [DOI] [PubMed] [Google Scholar]
- 100.Shahid M., Lee M. Y., Piplani H., et al. Centromere protein F (CENPF), a microtubule binding protein, modulates cancer metabolism by regulating pyruvate kinase M2 phosphorylation signaling. Cell Cycle . 2018;17(24):2802–2818. doi: 10.1080/15384101.2018.1557496. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 101.Zanini I. M., Soneson C., Lorenzi L. E., Azzalin C. M. Human cactin interacts with DHX8 and SRRM2 to assure efficient pre-mRNA splicing and sister chromatid cohesion. Journal of Cell Science . 2017;130(4):767–778. doi: 10.1242/jcs.194068. [DOI] [PubMed] [Google Scholar]
- 102.Hwang H. C., Clurman B. E. Cyclin E in normal and neoplastic cell cycles. Oncogene . 2005;24(17):2776–2786. doi: 10.1038/sj.onc.1208613. [DOI] [PubMed] [Google Scholar]
- 103.Malumbres M., Barbacid M. Mammalian cyclin-dependent kinases. Trends in Biochemical Sciences . 2005;30(11):630–641. doi: 10.1016/j.tibs.2005.09.005. [DOI] [PubMed] [Google Scholar]
- 104.Caldon C. E., Sergio C. M., Burgess A., Deans A. J., Sutherland R. L., Musgrove E. A. Cyclin E2 induces genomic instability by mechanisms distinct from cyclin E1. Cell Cycle . 2013;12(4):606–617. doi: 10.4161/cc.23512. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 105.Shiomi N., Mori M., Tsuji H., et al. Human RAD18 is involved in S phase-specific single-strand break repair without PCNA monoubiquitination. Nucleic Acids Research . 2007;35(2, article e9) doi: 10.1093/nar/gkl979. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 106.Watanabe K., Iwabuchi K., Sun J., et al. RAD18 promotes DNA double-strand break repair during G1 phase through chromatin retention of 53BP1. Nucleic Acids Research . 2009;37(7):2176–2193. doi: 10.1093/nar/gkp082. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 107.Seo D. W., You S. Y., Chung W.-J., Cho D.-H., Kim J.-S., Oh J. S. Zwint-1 is required for spindle assembly checkpoint function and kinetochore-microtubule attachment during oocyte meiosis. Scientific Reports . 2015;5(1, article 15431) doi: 10.1038/srep15431. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 108.Molli P. R., Li D. Q., Bagheri-Yarmand R., et al. Arpc1b, a centrosomal protein, is both an activator and substrate of Aurora A. The Journal of Cell Biology . 2010;190(1):101–114. doi: 10.1083/jcb.200908050. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 109.Liu K., Kang M., Liao X., Wang R. Genome-wide investigation of the clinical significance and prospective molecular mechanism of minichromosome maintenance protein family genes in patients with lung adenocarcinoma. PLoS One . 2019;14(7, article e0219467) doi: 10.1371/journal.pone.0219467. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 110.Snyder M., He W., Zhang J. J. The DNA replication factor MCM5 is essential for Stat1-mediated transcriptional activation. Proceedings of the National Academy of Sciences of the United States of America . 2005;102(41):14539–14544. doi: 10.1073/pnas.0507479102. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 111.Saelee P., Chaiwerawattana A., Ogawa K., Cho Y. M., Tiwawech D., Suktangman V. Clinicopathological significance of BRCA1 promoter hypermethylation in Thai breast cancer patients. Asian Pacific Journal of Cancer Prevention . 2014;15(24):10585–10589. doi: 10.7314/APJCP.2014.15.24.10585. [DOI] [PubMed] [Google Scholar]
- 112.Howlett N. G., Taniguchi T., Olson S., et al. Biallelic inactivation of BRCA2 in Fanconi anemia. Science . 2002;297(5581):606–609. doi: 10.1126/science.1073834. [DOI] [PubMed] [Google Scholar]
- 113.Guertin A. D., Li J., Liu Y., et al. Preclinical evaluation of the WEE1 inhibitor MK-1775 as single-agent anticancer therapy. Molecular Cancer Therapeutics . 2013;12(8):1442–1452. doi: 10.1158/1535-7163.MCT-13-0025. [DOI] [PubMed] [Google Scholar]
- 114.Bryan B. A., Dyson O. F., Akula S. M. Identifying cellular genes crucial for the reactivation of Kaposi’s sarcoma-associated herpesvirus latency. The Journal of General Virology . 2006;87(3):519–529. doi: 10.1099/vir.0.81603-0. [DOI] [PubMed] [Google Scholar]
- 115.Kim K. C., Choi E. H., Lee C. Axl receptor tyrosine kinase is a novel target of apigenin for the inhibition of cell proliferation. International Journal of Molecular Medicine . 2014;34(2):592–598. doi: 10.3892/ijmm.2014.1804. [DOI] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
The original data used to support the findings of this study are available at Gene Expression Omnibus database (https://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE146773).