1. Introduction
Glioblastoma (GBM) is one of the most common and lethal primary tumors, which has a poor prognosis and patients usually survive less than 15 months following diagnosis [
1,
2]. It is notoriously difficult to treat due to its diffuse nature and our limited knowledge of its molecular pathogenesis [
3]. The important steps for determining the optimal therapeutic strategies are understanding the mechanisms of the dynamic processes and identification of new potential biological modules.
Compared with the bulk RNA sequencing, single-cell RNA sequencing (scRNA-seq) can provides important information for inter-cellular transcriptomic heterogeneity and dissecting the interplay between the cancer cells and the associated microenvironment. scRNA-seq is increasingly used to study gene expression at the level of individual cells and graduated processes such as development and differentiation, adding another dimension to understand gene expression regulation and dynamics [
4]. Occurrence and development of cancers are governed by complex networks of interacting intercellular and intracellular signals [
5,
6]. 
Complex biological networks are able to reveal biological mechanisms [
7]. Moreover, differential network is often used to identify the kernel modules causing diversity by integrating dynamic gene expression changes. Bai Zhang proposed the differential dependency network (DNN) method [
8], which is based on local dependency, to detect topological changes across different biological conditions. A differential network-based methodology [
9] can identify candidate target genes and chemical compounds for reverting disease phenotypes. BioNetStat is a tool for biological networks differential analysis by the methods grounded on network theory [
10]. Furthermore, crucial changes among networks of different states are capable of reflecting on the development of living organisms [
11]. Therefore, it is critical to discover the kernel differential subgraph (KDS) which leads to drastic changes. Discovering the KDS is similar to the Steiner Tree problem which is a NP-hard problem [
12]. Topology-based KDS (TKDS) [
13] is a method to discover the KDS from gene regulatory networks of omics datasets. SMT-Neurophysiology [
12] is a tool in the form of an approximation to the Steiner Minimal Tree (SMT) algorithm, which is to find biomedically-meaningful KDS in neurophysiology. These methods could discover the KDS in different states. However, the accuracy of these methods was not high enough. And moreover, these methods did not fully consider the changes of topology.
The kernel differential subgraph (KDS) is a small-scale connected network with the differential nodes and edges. Considering the multiple factors affecting the subgraph, we developed a criterion to discover the kernel differential subgraph (CKDS). Specially, the criterion considers the connectivity and scale of KDS, the topological difference of nodes and function relevance between genes in the KDS. 
To demonstrate the effectiveness of our method, we applied CKDS to simulated datasets and three scRNA-seq datasets including GBM, fetal human cortical neurons (FHCN) and neural differentiation. Additional network topology and functional enrichment analyses were performed on the extracted KDSs influencing GBM closely.
  2. Materials and Methods 
  2.1. A Framework of a Criterion to Discover the Kernel Differential Subgraph (CKDS)
  2.1.1. Raw Data Pre-Treatment and Differential Expressed Genes Identification
Raw scRNA-seq counts data is usually downloaded from the Gene Expression Omnibus (GEO, 
http://www.ncbi.nlm.nih.gov/geo/). The raw counts data is converted to read-counts-per-million (CPM) gene expression matrix using the ‘cpm’ function by R package ‘edgeR’ [
14]. The processed matrix is divided into cancer and normal gene expression matrix shown in 
Figure 1.
Differential expressed genes (DEGs) are detected from the processed scRNA-seq data by R package ‘edgeR’. Similar to the analysis of differential gene expression, we use ‘
p-value, 
p.adjust and  log
2FC’ to obtain the DEGs by the gene expression. The R function ‘
p.adjust’ is to adjust the p-values by ‘false discovery rate (fdr)’ method [
15]. Fold change (FC) [
16] is calculated simply as the ratio of the difference between final value and the initial value over the original value. In the field of bioinformatics, we commonly use log
2 for expressing the FC (log
2FC). The genes with the 
p-value < 0.01, 
p.adjust < 0.05 and 
 are considered as DEGs. 
  2.1.2. Single-Cell Transcriptome Network Construction by Differential Expressed Genes
Single-cell transcriptome data may lead to high false positives [
17]. Therefore, integrated multi-omics data analysis has become a trend to solve it in biological network analysis [
18]. Proteomics and transcriptomics data are integrated to construct a network [
19], in which protein–protein networks (PPN) are used as a backbone network, and Pearson correlation coefficient (PCC) between expression of each pair of genes is used as the weight of edge. In this work, DEGs are connected with known protein–protein interactions (PPIs) documented in STRING database (v10.5, 
https://string-db.org/cgi/input.pl). Previous research has shown that when applied to real data, only edges with top 10% PCC were reserved [
20]. In the generated STRING network, compared with the original one, over 90% edges disappear, and due to the generic property that the network structure would remain stable during the stable biological stage. At the same time, in order to ensure the effectiveness of PCC, we set 
 [
21]. Thus, the association of two differential genes is defined as the weight of the edge, and only genes with the value of top 10% PCC and 
 are reserved.
  2.1.3. Calculating Differential Value of Genes by Graphlet Vector
Graphlets are small connected non-isomorphic induced subgraphs containing 2, 3, 4, or more nodes [
22,
23,
24]. The graphlets of 2–4 nodes are shown in 
Figure 2. For 2, 3, and 4-node graphlets, the nodes in same color mean the nodes with the same topological structure (degree). There are 15 different kinds of nodes labelled orbits0-orbits14. Each node in the network obtains specific graphlet vector by calculating the frequency in 15 dimensions. 
For the node 
  denotes the 
ith coordinate of its signature vector, i.e. 
 is the number of times node 
 is touched by an orbit 
i in 
. The distance 
 between the 
ith orbits of nodes 
 and 
 is defined as [
25]:
          where 
 is the weight of orbit 
i that accounts for dependencies between orbits [
25].
As shown in Equation (2), the 
d-value between nodes 
 and 
 means the total distance.
          
The distance 
 is in (0, 1), where distance 0 means that signatures of nodes 
 and 
 are identical [
25]. The more topological structure varies, the larger 
d-value is. Nodes with 
d-value larger than 0.4 [
23] are selected into the differential nodes set D for the further analysis.
  2.1.4. The Criterion to Extract Kernel Differential Subgraph
Kernel differential subgraph extraction is similar to Steiner Tree problem, which is an NP-hard problem. In this work, the criterion to extract KDS is present by four principles. Firstly, the subgraph should be connected. A connected subgraph can discover the dense relationship between molecules. Secondly, the scale of subgraph should be as small as possible. A KDS is the most core subgraph with small scale of the entire network. Thirdly, the d-value of nodes with large topological difference calculated by graphlet should be as large as possible. Nodes with large differences in topology are often key nodes in the network. These nodes will be selected to extract the KDS. Fourthly, the functional relevance between genes should be as strong as possible. It means the higher weight of edges will be chosen to extract the KDS.
There is a cancer network 
 and a normal network 
 representing two different states. 
 represents the set of 
v common nodes; 
 and 
 represent the set of edges respectively. Algorithm 1 describes the criterion to discover the KDS (CKDS), where 
 represents the weight set of edges. The set 
 represents the set of differential nodes with 
d-value 
. According to the sorted 
d-value 
 in descending order, we selected the differential nodes 
 (
) [
23] to add in KDS. When considering a new path added to KDS, 
 and 
 mean the sum of 
d-value of all nodes and weight of all edges on the path. The parameter 
 and 
 were coefficient designed to measure the importance of 
 and 
. The estimation of the vector 
 is discussed in 
Section 3. 
(
 and 
 indicates the KDS of different state. The pseudo code of this algorithm is shown below.
          
| Algorithm 1: the criterion to discover the KDS (CKDS) | 
| Input: network , network , common differential node set  with their d-value . Output: KDS of  and .
 Sort  by their d-value  in descending order
 For  from 1 to 2
 Add  to
 For  in sorted D do
 if  is existed in
 continue
 else if
 if  directly connect with any node existed in
 add  and its edge to
 else if
 calculate the score of the shortest paths from  to each node in  by
 Equation (3),
 Add the path that has the highest  to
 End
 Return
 End
 Intersect  and  to get KDS of  and
 | 
  2.2. Topological Analyses on Kernel Differential Subgraph
The centrality indexes including degree centrality (DC) [
27], betweenness centrality (BC) [
28], closeness centrality (CC) [
29], and eigenvector centrality (EC) [
30] were used to analyze the KDS. For a KDS 
, 
 and 
 represent the set of nodes and edges respectively. Four centrality indexes are defined as follows,
DC: DC means how many nodes connected to node 
, and it can measure node 
’s centrality apparently. 
 is the number of node 
’s neighbors. The degree of node 
 is formalized by Equation (4), where
        
 BC: BC is the average length of the shortest paths through node 
. Equation (5) is as follow:
 In which,  is the total number of shortest paths from node  to node .  means the number of those paths that go through node .
CC: In the network 
V with 
 nodes, closeness centrality means the degree that node 
 communicates with other nodes set 
. It is calculated by Equation (6):
  is the distance of the shortest path from node  to node .
EC: EC is a measure of the influence of node 
 on a network. It assigns relative scores to all nodes in the network based on the concept that connections to high-scoring nodes contribute more to the score of the node in question than equal connections to low-scoring nodes [
30]. The EC score of node 
 is shown as Equation (7):
  is the eigenvector corresponding to the largest eigenvalue from A which is the adjacency matrix of KDS.
Different topology analysis methods rely on different network topology structures, which may not comprehensively balance the importance of genes in different biological states. Therefore, we employed four centrality indexes (one local measurement method ’DC’ and three global measurement methods ‘BC, CC, and EC’). According to four centrality indexes, four scores of each node in the subgraph was calculated and normalized to the number in the range 0 to 1. Each node would have a score to evaluate the topological differences in Equation (8). Multiple centralities can be considered comprehensively to evaluate the node topology.
        
 means four normalized centrality indexes of node . In the following study, we focused on the nodes with top 10% score, which were with large topological differences in the KDS.
  2.3. Functional Enrichment Analyses
The Gene Ontology (GO) and the Kyoto Encyclopedia of Genes and Genomes (KEGG) analyses were performed to understand the underlying biological mechanisms. GO analyses explored the biological significance of genes by R package ‘clusterProfiler’ [
31]. The enriched GO terms with Gene-Count > 5 and 
p-value < 0.05 were selected for further assessment [
32]. In this paper, we also focused on the top 10% frequently occurring genes in the GO terms. The KEGG analyses were performed on pathways with 
p-value < 0.05. 
  2.4. Evaluation Indicators
The number of essential genes in the KDS could evaluate the performance of the algorithm. The more essential genes were found, the better the performance of the algorithm was.
        
As shown in Equation (9),  is calculated to evaluate the performance.  means the number of essential genes. is the number of essential genes in KDS, and  is the number of essential genes which are not predicted in KDS.  is similar to the evaluation indicator ‘Precision’ in binary classification problem.
To better evaluate the performance, true negative (TN), false positive (FP), false negative (FN), and true positive (TP) [
33] are used to calculate evaluation indicators, including Accuracy, Precision (
), Recall, and F1-Score as following.
        
Moreover, F1-Score is a handy indicator for measuring the accuracy of a binary classification model. F1-Score takes Precision and Recall into account, which ranges from 0 to 1. The algorithm is more excellent if the F1-Score is closer to 1.
  3. Results and Discussion
  3.1. Simulated Data Generation
According to the principles of biomolecular network [
34], we used a simulated data generating algorithm [
35] to generate simulated data. 
The algorithm could generate two networks with a list of essential genes and two sets of gene expression based on some parameters. The parameters of 
 and 
 mean the number of nodes, and 
 means the number of essential genes in the two networks. The parameter 𝜌 means the proportion of differential edges driven by perturbed genes [
35]. The smaller 𝜌 is, the more difficult it is to find essential genes. In this paper, 
, 
, 
.
Two hundred groups of simulated datasets were generated, in which 100 groups (Dataset I) were to get the vector  in Equation (3) and 100 groups (Dataset II) were to compare the performance of CKDS with other methods. 
As the Equation (3) shows, the score of path is influenced by  and , and parameter  were designed to measure the importance of  and . In order to distinguish which variable is more influential, the sum of  was designed to be 1. For each of the 100 groups (Dataset I), the parameter  were taken from 0 to 1 respectively. Thus, the optimal ratio of  can be generated by conducting experiments on resulted KDS’s prediction precision by Equation (11).
As shown in 
Figure 3, the parameter 
 around 0.5 (
) gets the KDS with the highest Precision (
. It reflects that 
 is as important as 
 According to the four principles, the CKDS algorithm considers the connectivity and scale of KDS, the topological difference of nodes and function relevance between genes in the KDS. The reason why the ratio of 
a to 
b is 1:1 is that when a new shortest path is added to the KDS, the ratio of the number of the points and edges is 1:1. The newly shortest added path meets four principles very well. The value of 
 and 
 are between 0 and 1 respectively. The ratio of 
 to 
 is close to 1. 
The experiment results showed that when the ratio of 
 is about to 1, the generated KDS can perform well and acquire the reliable result. According to the four principles of CKDS, the final equation to calculate the path in this paper is shown as Equation (14).
        
  3.2. Comparison with other Methods on Simulated Datasets
In our work, we compared CKDS with other three differential kernel subgraph extraction algorithms: SMT-Neurophysiology (KDS-SMT) [
12], TDKS [
13] and KDS based on Floyd (KDS-Floyd) [
36]. Each algorithm would get a KDS with essential genes. One hundred groups of simulated datasets(Dataset II) with 10 essential genes were generated to assess the performance of the four algorithms. 
After calculating the evaluation indicators by Equations (10)–(13), the results show CKDS is superior to other three algorithms on those measures (
Table 1). It proves that CKDS has a good performance to find KDS with essential genes. This is because that CKDS combines multiple principles, which is capable of taking various kinds of differences into consideration.
  3.3. The Kernel Differential Subgraph Analyses for Single-Cell RNA-Seq Datasets of Glioblastoma
  3.3.1. Single-Cell RNA-Seq Datasets of Glioblastoma and Fetal Human Cortical Neuron
The raw scRNA-seq data was downloaded from the GEO database. To compare GBM and normal cells, 134 fetal human cortical neurons (FHCN) [
37] (GSE67835, 25 June, 2019) and 3589 human glioblastoma cells from Darmanis et al [
38] (GSE84465, 25 June, 2019) were downloaded to discover the KDS between two states.
Using two scRNA-seq datasets, differential expressed analyses were performed by ‘egdeR’ [
14]. As shown in 
Figure 4a, 3547 genes were defined as DEGs. Two networks were constructed by the method illustrated in 
Section 2.1.2. The GBM network consists of 912 nodes with 1986 edges and the FHCN network consisted of 518 nodes with 594 edges. There were 387 common genes in two networks. The common genes were sorted by calculating the graphlet vector in descending order. Finally, using the CKDS algorithm, the KDS of GBM and FHCN was discovered, consisting of 106 genes with a total of 141 interactions in 
Figure 4b.
  3.3.2. The Analyses of Kernel Differential Subgraph
In order to explore the biological mechanisms of GBM, we used network topology and functional enrichment analysis methods on the extracted KDS. However, there is no golden standard in evaluate KDSs in real bio-network. In this paper, the effectiveness of the method can be accessed by literature mining.
According to four centrality indexes, each node in KDS was calculated by Equation (6). We focused on the top 10% nodes with the highest score in KDS. Eleven genes with large topological differences (
TGFB1, 
ITPKB, 
HRAS, 
NFKB1, 
PML, 
MYD88, 
ACTN1, 
CSF1, 
GAS6, 
DAB2 and 
CSNK2B) were chosen from the KDS of GBM and FHCN in 
Figure 4(b). Eight of the eleven genes were supported by the literature arguing that they had great influence on GBM. Among them, 
TGFB1, 
PML and 
GAS6 are therapeutic targets for GBM. 
NFKB1, 
CSF1 and 
LYN are regulatory genes which facilitate progression of GBM. 
MYD88 is a biomarker to divide GBM patient. 
ACTN1 is regulated during the development of astrocytoma cells. 
HRAS is a driver gene that expression of oncogenic 
HRAS results in a malignant phenotype in glioma cell lines (
Table 2). 
The eleven genes that top 10% frequently occurred in the enriched GO terms were selected from GBM and FHCN and marked in red in 
Figure 4(b). Supported by the literature, ten of the eleven genes had great influence on GBM. Among them, 
EGFR, 
DAXX, 
ANXA1, 
ANXA2 and 
LYN are regulatory genes which promote glioma growth. 
HSPA1B, 
EPHA3, 
INSR and 
TGFB1 are functional therapeutic targets in glioblastoma (
Table 3). 
MAP2K1 is enriched in the KEGG pathway(hsa05214) for GBM.
By KEGG enrichment analysis, there was an enriched KEGG pathway (hsa05214: HRAS, MAP2K1, EGFR and CCND1) for GBM. 
In summary, by the topology and functional enrichment analyses on the KDS, seventeen genes (nine regulatory genes, six therapeutic targets, one driver gene, one biomarker) and one pathway were found, which were closely interrelated with GBM. The experiments indicated that the KDS extracted by CKDS reflected the large differences between GBM and FHCN, which highly influenced on the development of GBM.
  3.4. The Kernel Differntial Subgraph Analyses for Single-Cell RNA-Seq Datasets of Neural Differentiation
  3.4.1. Single-Cell RNA-Seq Datasets of Neural Differentiation
To further explore the effects of neurodevelopmental stages and the development of GBM, the raw scRNA-seq data of neural differentiation about neural stem cell lineages from adult mice, including 152 activated neural stem cells (aNSCs), 64 produce neural progenitor cells (NPCs) and 31 astrocytes (Asts) were downloaded from the reference [
55]. Three different stages of neural stem cell lineage are divided to Group A (aNSCs and NPCs) and Group B (NPCs and Asts).
Differential expressed analysis was performed by 
‘egdeR’ packages. 1039 DEGs and 790 DEGs were extracted from two groups respectively (
Figure 5a,b). The networks were constructed by 
Section 2.1.2. In Group A, the aNSCs network consisted of 504 nodes with 1492 edges and the NPCs network consisted 686 nodes with 2682 edges. In Group B, the NPCs network consisted of 544 nodes with 2686 edges and the Asts network consisted of 559 nodes with 2724 edges. There were 485 and 517 common genes in two groups respectively. The common genes in each group were sorted by calculating the graphlet vector in descending order. 
Using the CKDS algorithm, two KDSs of the two groups were discovered, consisting of 107 genes with 151 interactions in KDS-A and 109 genes with 144 edges in KDS-B, as shown in 
Figure 5c,d.
  3.4.2. Kernel Differential Subgraph Analyses
In Group A, according to four centrality indexes, top 10% genes with large topological differences in KDS-A was calculated by Equation (6). Eleven genes (
Src, 
Egfr, 
Gab1, 
App, 
Numb, 
Plcg1, 
Efnb3, 
Ptprk, 
Actn1, 
Notch2 and 
Gsn) were chosen from the KDS-A. The border lines of these genes are bolded in 
Figure 5c. Supported by the literature (
Table 4), eight of the eleven genes have influence on GBM. Among them, 
Src is a driver gene which inhibit the growth of GBM and reduce its survival. 
Egfr, 
Gab1, 
App and 
Efnb3 are regulatory genes which promote glioma cell proliferation. 
Numb has effective anti-cancer therapy in glioblastoma. 
Plcg1 induces GBM radioresistance. 
Notch2 and 
miR-181a have potential prognostic value as tumor biomarkers in GBM patients. 
Compare with Group A, only few genes (
Hsp90aa1, 
Eprs and 
Hsp90ab1) supported by the literature references in KDS-B which have influence on GBM (
Table 5).
From aNSCs to NPCs stage, top 10% frequently occurring genes in the enriched GO terms (
Rab4a, 
Pten, 
Egfr, 
Rab10, 
Rac1, 
Fgfr1, 
Gnai1, 
Ntrk2, 
Rhob, 
Kras and 
Rhou) were selected to look for the biomarkers. These 11 gene nodes are marked in red in 
Figure 5c. Supported by the literature, eight of the eleven genes have influence on GBM. Among them, 
Pten and 
Rac1 are driver genes which inhibit the migration and invasion of GBM. 
Egfr, 
Kras, 
Gnai1, 
Ntrk2 and 
Rhob are regulatory genes which drive the initiation and progression of glioma. 
Fgfr1 induces GBM Radioresistance. In KDS-B, seven genes (
Hsp90aa1, 
Hsp90ab1, 
Atp1b2, 
Trp53, 
Hspa8, 
Usp22 and 
Atp1a2) are supported by the literature references which have influence on GBM (
Table 6 and 
Table 7). 
By KEGG enrichment analyses, the KDS enriched lots of KEGG pathways related to cancer, particularly, the KEGG pathway mmu05214 (Egfr, Plcg1, Kras and Pten) is exactly the pathway of GBM. 
In summary, the KDS-A involved ten regulatory genes, three driver genes, one biomarkers, one therapeutic target of GBM. These fifteen genes and the KEGG pathway in KDS-A highly influenced on the development of GBM. However, there was few genes and no pathway of GBM in KDS-B. 
The topological and functional enrichment analyses indicated the genes and pathways associated with glioma and cancers are significantly reduced during the period from NPC to Ast. It suggests that the critical period of GBM development is from aNSC to NPC other than NPC to Ast. 
Gliomas are malignant primary tumors of the central nervous system. Their cell-of-origin is thought to be a neural progenitor or stem cell that acquires mutations leading to oncogenic transformation [
76]. By the CKDS algorithm, we proved that the stage of aNSCs to NPCs is a critical period affecting the development of GBM.
  4. Conclusions
Complex biological networks are used to explore the mechanisms in complex diseases. Crucial changes in different networks reflect on the development of living organisms. Therefore, it is significant to discover the KDS leading to drastic changes.
In this work, we developed a criterion to discover KDS called CKDS. The criterion fully considered the factors affecting KDS, including the connectivity and scale of KDS, the topological difference of nodes and function relevance between genes in the KDS. As a result, the CKDS algorithm discovered the KDS in different states.
The CKDS algorithm was applied to simulated datasets and three scRNA-seq datasets including GBM, FHCN, and neural differentiation. Compared with the other state-of-art methods, the CKDS algorithm outperformed in simulated datasets to discover the KDSs. In the scRNA-seq datasets, we performed the network topology and functional enrichment analyses on the extracted KDSs. Many genes, including genetic biomarkers, driver genes, regulatory genes, and therapeutic targets, and pathways in the KDSs are closely interrelated to GBM, indicating that CKDS could express the kernel difference between different states. Moreover, the KEGG pathway of GBM is only in neural differentiation period from aNSC to NPC other than NPC to Ast, indicating that the period from aNSC to NPC is an important neural differentiation period affecting the development of GBM. In addition, the CKDS algorithm provides a unique perspective in identifying cell-type-specific genes and KDSs.
Based on the prediction of CKDS, the genes that were not supported by literature will be verified by conducting a series of biological experiments in the future. Moreover, the CKDS algorithm can be extended to scRNA-seq datasets of other complex diseases for detecting the molecular features of pathogenesis mechanisms and biomarkers.
   
  
    Author Contributions
Conceptualization, J.X. and J.W.; methodology, J.S.; software, J.S.; data curation, J.F.; resources, F.Y.; writing—original draft preparation, J.X., J.S., J.W., T.W. and Q.N.; writing—review and editing, J.X., J.S.; project administration, J.X.; funding acquisition, J.X. All authors have read and agreed to the published version of the manuscript. 
Funding
This work was partially supported by the National Natural Science Foundation of China [No. 61873156], the Project of NSFS [No. 17ZR1409900] and NIH grant U54-CA217378.
Conflicts of Interest
There is no conflict of interest in this manuscript.
References
- Goffart, N.; Kroonen, J.; Rogister, B. Glioblastoma-Initiating Cells: Relationship with Neural Stem Cells and the Micro-Environment. Cancers 2013, 5, 1049–1071. [Google Scholar] [CrossRef] [PubMed]
- Stupp, R.; E Hegi, M.; Mason, W.P.; Bent, M.J.V.D.; Taphoorn, M.J.; Janzer, R.C.; Ludwin, S.K.; Allgeier, A.; Fisher, B.; Bélanger, K.; et al. Effects of radiotherapy with concomitant and adjuvant temozolomide versus radiotherapy alone on survival in glioblastoma in a randomised phase III study: 5-year analysis of the EORTC-NCIC trial. Lancet Oncol. 2009, 10, 459–466. [Google Scholar] [CrossRef]
- Claes, A.; Idema, A.J.; Wesseling, P. Diffuse glioma growth: A guerilla war. Acta Neuropathol. 2007, 114, 443–458. [Google Scholar] [CrossRef] [PubMed]
- McCarthy, D.J.; Campbell, K.R.; Lun, A.T.L.; Wills, Q.F. Scater: pre-processing, quality control, normalization and visualization of single-cell RNA-seq data in R. Bioinform. 2017, 33, 1179–1186. [Google Scholar] [CrossRef] [PubMed]
- Zhang, J.; Guan, M.; Wang, Q.; Zhang, J.; Zhou, T.; Sun, X. Single-cell transcriptome-based multilayer network biomarker for predicting prognosis and therapeutic response of gliomas. Brief Bioinform. 2019. [Google Scholar] [CrossRef]
- Wang, Y.; Wu, H.; Yu, T. Differential gene network analysis from single cell RNA-seq. J. Genet. Genom. 2017, 44, 331–334. [Google Scholar] [CrossRef]
- Pina, C.; Teles, J.; Fugazza, C.; May, G.; Wang, D.; Guo, Y.; Soneji, S.; Brown, J.; Edén, P.; Ohlsson, M.; et al. Single-Cell Network Analysis Identifies DDIT3 as a Nodal Lineage Regulator in Hematopoiesis. Cell Rep. 2015, 11, 1503–1510. [Google Scholar] [CrossRef]
- Zhang, B.; Li, H.; Riggins, R.B.; Zhan, M.; Xuan, J.; Zhang, Z.; Hoffman, E.P.; Clarke, R.; Wang, Y. Differential dependency network analysis to identify condition-specific topological changes in biological networks. Bioinform. 2008, 25, 526–532. [Google Scholar] [CrossRef]
- Ali, M.; Del Sol, A. Modeling of Cellular Systems: Application in Stem Cell Research and Computational Disease Modeling. In Methods in Molecular Biology; Springer Science and Business Media LLC: Berlin, Germany, 2018; pp. 129–138. [Google Scholar]
- Jardim, V.C.; Santos, S.D.S.; Fujita, A.; Buckeridge, M.S. BioNetStat: A Tool for Biological Networks Differential Analysis. Front. Genet. 2019, 10, 594. [Google Scholar] [CrossRef]
- Ideker, T.; Krogan, N.J. Differential network biology. Mol. Syst. Boil. 2012, 8, 565. [Google Scholar] [CrossRef]
- Islam, S.; Sarwar, D.M. Identifying Brain Region Connectivity using Steiner Minimal Tree Approximation and a Genetic Algorithm. 2019; 626598. [Google Scholar]
- Xie, J.; Lu, D.; Li, J.; Wang, J.; Zhang, Y.; Li, Y.; Nie, Q. Kernel differential subgraph reveals dynamic changes in biomolecular networks. J. Bioinform. Comput. Boil. 2018, 16, 1750027. [Google Scholar] [CrossRef] [PubMed]
- Robinson, M.D.; McCarthy, D.J.; Smyth, G.K. edgeR: A Bioconductor package for differential expression analysis of digital gene expression data. Bioinformatics 2010, 26, 139–140. [Google Scholar] [CrossRef] [PubMed]
- Benjamini, Y.; Hochberg, Y. Controlling the False Discovery Rate: A Practical and Powerful Approach to Multiple Testing. J. R. Stat. Soc. Ser. B (Statistical Methodol. 1995, 57, 289–300. [Google Scholar] [CrossRef]
- Cortese, R.; Hartmann, O.; Berlin, K.; Eckhardt, F. Correlative gene expression and DNA methylation profiling in lung development nominate new biomarkers in lung cancer. Int. J. Biochem. Cell Boil. 2008, 40, 1494–1508. [Google Scholar] [CrossRef] [PubMed]
- Wang, Y.; Navin, N.E. Advances and applications of single-cell sequencing technologies. Mol. Cell 2015, 58, 598–609. [Google Scholar] [CrossRef]
- Bock, C.; Farlik, M.; Sheffield, N.C. Multi-Omics of Single Cells: Strategies and Applications. Trends Biotechnol. 2016, 34, 605–608. [Google Scholar] [CrossRef]
- Zhang, P.; Yang, M.; Zhang, Y.; Xiao, S.; Lai, X.; Tan, A.; Du, S.; Li, S. Dissecting the Single-Cell Transcriptome Network Underlying Gastric Premalignant Lesions and Early Gastric Cancer. Cell Rep. 2019, 27, 1934–1947.e5. [Google Scholar] [CrossRef]
- Chen, P.; Li, Y.; Liu, X.; Liu, R.; Chen, L. Detecting the tipping points in a three-state model of complex diseases by temporal differential networks. J. Transl. Med. 2017, 15, 217. [Google Scholar] [CrossRef]
- Puniya, B.L.; Kulshreshtha, D.; Verma, S.P.; Kumar, S.; Ramachandran, S. Integrated gene co-expression network analysis in the growth phase of Mycobacterium tuberculosis reveals new potential drug targets. Mol. BioSyst. 2013, 9, 2798. [Google Scholar] [CrossRef]
- Przulj, N.; Corneil, D.G.; Jurisica, I. Modeling interactome: Scale-free or geometric? Bioinform. 2004, 20, 3508–3515. [Google Scholar] [CrossRef]
- Milenković, T.; Pržulj, N. Uncovering Biological Network Function via Graphlet Degree Signatures. Cancer Informatics 2008, 6, 257–273. [Google Scholar] [CrossRef] [PubMed]
- Malod-Dognin, N.; Ban, K.; Pržulj, N. Unified Alignment of Protein-Protein Interaction Networks. Sci. Rep. 2017, 7, 953. [Google Scholar] [CrossRef]
- Milenković, T.; Ng, W.L.; Hayes, W.; Przulj, N. Optimal Network Alignment with Graphlet Degree Vectors. Cancer Informatics 2010, 9, 121–137. [Google Scholar] [CrossRef] [PubMed]
- Smoot, M.E.; Ono, K.; Ruscheinski, J.; Wang, P.L.; Ideker, T. Cytoscape 2.8: new features for data integration and network visualization. Bioinformatics 2011, 27, 431–432. [Google Scholar] [CrossRef] [PubMed]
- Jeong, H.; Mason, S.P.; Barabási, A.L.; Oltvai, Z.N. Lethality and centrality in protein networks. Nat. 2001, 411, 41–42. [Google Scholar] [CrossRef] [PubMed]
- Newman, M.J. A measure of betweenness centrality based on random walks. Soc. Networks 2005, 27, 39–54. [Google Scholar] [CrossRef]
- Sabidussi, G. The centrality index of a graph. Psychom. 1966, 31, 581–603. [Google Scholar] [CrossRef]
- Bonacich, P. Power and Centrality: A Family of Measures. Am. J. Sociol. 1987, 92, 1170–1182. [Google Scholar] [CrossRef]
- Yu, G.; Wang, L.G.; Han, Y.; He, Q.Y. clusterProfiler: An R Package for Comparing Biological Themes Among Gene Clusters. OMICS: A J. Integr. Boil. 2012, 16, 284–287. [Google Scholar] [CrossRef]
- Yuan, W.; Li, X.; Liu, L.; Wei, C.; Sun, D.; Peng, S.; Jiang, L. Comprehensive analysis of lncRNA-associated ceRNA network in colorectal cancer. Biochem. Biophys. Res. Commun. 2019, 508, 374–379. [Google Scholar] [CrossRef]
- Chawla, N.V.; Bowyer, K.W.; Hall, L.O.; Kegelmeyer, W.P. SMOTE: Synthetic Minority Over-sampling Technique. J. Artif. Intell. Res. 2002, 16, 321–357. [Google Scholar] [CrossRef]
- Barabási, A.L. Scale-free networks: A decade and beyond. Science 2009, 325, 412–413. [Google Scholar] [CrossRef] [PubMed]
- Zhang, X.F.; Ou-Yang, L.; Yan, H. Incorporating prior information into differential network analysis using non-paranormal graphical models. Bioinform. 2017, 33, 2436–2445. [Google Scholar] [CrossRef] [PubMed]
- Hougardy, S. The Floyd–Warshall algorithm on graphs with negative cycles. Inf. Process. Lett. 2010, 110, 279–281. [Google Scholar] [CrossRef]
- Darmanis, S.; Sloan, S.A.; Zhang, Y.; Enge, M.; Caneda, C.; Shuer, L.M.; Gephart, M.G.H.; Barres, B.A.; Quake, S.R. A survey of human brain transcriptome diversity at the single cell level. Proc. Natl. Acad. Sci. USA 2015, 112, 7285–7290. [Google Scholar] [CrossRef]
- Darmanis, S.; Sloan, S.A.; Croote, D.; Mignardi, M.; Chernikova, S.; Samghababi, P.; Zhang, Y.; Neff, N.; Kowarsky, M.; Caneda, C.; et al. Single-Cell RNA-Seq Analysis of Infiltrating Neoplastic Cells at the Migrating Front of Human Glioblastoma. Cell Rep. 2017, 21, 1399–1410. [Google Scholar] [CrossRef]
- Chen, Y.; Liu, P.; Sun, P.; Jiang, J.; Zhu, Y.; Dong, T.; Cui, Y.; Tian, Y.; An, T.; Zhang, J.; et al. Oncogenic MSH6-CXCR4-TGFB1 Feedback Loop: A Novel Therapeutic Target of Photothermal Therapy in Glioblastoma Multiforme. Theranostics 2019, 9, 1453–1473. [Google Scholar] [CrossRef]
- Doll, S.; Urisman, A.; Oses-Prieto, J.A.; Arnott, D.; Burlingame, A.L. Quantitative Proteomics Reveals Fundamental Regulatory Differences in Oncogenic HRAS and Isocitrate Dehydrogenase (IDH1) Driven Astrocytoma. Mol. Cell Proteomics 2017, 16, 39–56. [Google Scholar] [CrossRef]
- Kina, I.; Sultuybek, G.K.; Soydas, T.; Yenmis, G.; Biceroglu, H.; Dirican, A.; Uzan, M.; Ulutin, T. Variations in Toll-like receptor and nuclear factor-kappa B genes and the risk of glioma. Br. J. Neurosurg. 2019, 33, 165–170. [Google Scholar] [CrossRef]
- Amodeo, V.A.D.; Betts, J.; Bartesaghi, S.; Zhang, Y.; Richard-Londt, A.; Ellis, M.; Roshani, R.; Vouri, M.; Galavotti, S.; Oberndorfer, S. A PML/Slit Axis Controls Physiological Cell Migration and Cancer Invasion in the CNS. Cell Rep. 2017, 20, 411–426. [Google Scholar] [CrossRef]
- Wang, W.; Zhao, Z.; Wu, F.; Wang, H.; Wang, J.; Lan, Q.; Zhao, J. Bioinformatic analysis of gene expression and methylation regulation in glioblastoma. J. Neurooncol. 2018, 136, 495–503. [Google Scholar] [CrossRef]
- Quick, Q.; Skalli, O. Alpha-actinin 1 and alpha-actinin 4: contrasting roles in the survival, motility, and RhoA signaling of astrocytoma cells. Exp. Cell Res. 2010, 316, 1137–1147. [Google Scholar] [CrossRef] [PubMed]
- De, I.; Steffen, M.D.; Clark, P.A.; Patros, C.J.; Sokn, E.; Bishop, S.M.; Litscher, S.; Maklakova, V.I.; Kuo, J.S.; Rodriguez, F.J.; et al. CSF1 overexpression promotes high-grade glioma formation without impacting the polarization status of glioma-associated microglia and macrophages. Cancer Res. 2016, 76, 2552–2560. [Google Scholar] [CrossRef] [PubMed]
- Hutterer, M.; Knyazev, P.; Abate, A.; Reschke, M.; Maier, H.; Stefanova, N.; Knyazeva, T.; Barbieri, V.; Reindl, M.; Muigg, A.; et al. Axl and Growth Arrest Specific Gene 6 Are Frequently Overexpressed in Human Gliomas and Predict Poor Prognosis in Patients with Glioblastoma Multiforme. Clin. Cancer Res. 2008, 14, 130–138. [Google Scholar] [CrossRef] [PubMed]
- Bonavia, R.; Inda, M.M.; Vandenberg, S.; Cheng, S.Y.; Nagane, M.; Hadwiger, P.; Tan, P.; Sah, D.W.Y.; Cavenee, W.K.; Furnari, F.B. EGFRvIII promotes glioma angiogenesis and growth through the NF-kappa B, interleukin-8 pathway. Oncogene 2012, 31, 4054–4066. [Google Scholar] [CrossRef]
- Fan, H.C.; Chen, C.M.; Chi, C.S.; Tsai, J.D.; Chiang, K.L.; Chang, Y.K.; Lin, S.Z.; Harn, H.J. Targeting Telomerase and ATRX/DAXX Inducing Tumor Senescence and Apoptosis in the Malignant Glioma. Int. J. Mol. Sci. 2019, 20, 200. [Google Scholar] [CrossRef] [PubMed]
- Moraes, L.A.; Kar, S.; Foo, S.L.; Gu, T.; Toh, Y.Q.; Ampomah, P.B.; Sachaphibulkij, K.; Yap, G.; Zharkova, O.; Lukman, H.M.; et al. Annexin-A1 enhances breast cancer growth and migration by promoting alternative macrophage polarization in the tumour microenvironment. Sci. Rep. 2017, 7, 17925. [Google Scholar] [CrossRef]
- Chen, L.; Lin, L.; Xian, N.; Zheng, Z. Annexin A2 regulates glioma cell proliferation through the STAT3-cyclin D1 pathway. Oncol. Rep. 2019, 42, 399–413. [Google Scholar] [CrossRef]
- Liu, W.M.; Huang, P.; Kar, N.; Burgett, M.; Muller-Greven, G.; Nowacki, A.S.; Distelhorst, C.W.; Lathia, J.D.; Rich, J.N.; Kappes, J.C.; et al. Lyn Facilitates Glioblastoma Cell Survival under Conditions of Nutrient Deprivation by Promoting Autophagy. PLOS ONE 2013, 8, e70804. [Google Scholar] [CrossRef]
- Halatsch, M.-E.; Löw, S.; Mursch, K.; Hielscher, T.; Schmidt, U.; Unterberg, A.; Vougioukas, V.I.; Feuerhake, F. Candidate genes for sensitivity and resistance of human glioblastoma multiforme cell lines to erlotinib. J. Neurosurg. 2009, 111, 211–218. [Google Scholar] [CrossRef]
- Offenhäuser, C.; Al-Ejeh, F.; Puttick, S.; Ensbey, K.S.; Bruce, Z.C.; Jamieson, P.R.; Smith, F.M.; Stringer, B.W.; Carrington, B.; Fuchs, A.V.; et al. EphA3 Pay-Loaded Antibody Therapeutics for the Treatment of Glioblastoma. Cancers 2018, 10, 519. [Google Scholar] [CrossRef] [PubMed]
- Ma, Y.F.; Tang, N.; Thompson, R.C.; Mobley, B.C.; Clark, S.W.; Sarkaria, J.N.; Wang, J.L. InsR/IGF1R Pathway Mediates Resistance to EGFR Inhibitors in Glioblastoma. Clin. Cancer Res. 2016, 22, 1767–1776. [Google Scholar] [CrossRef] [PubMed]
- Dulken, B.W.; Leeman, D.S.; Boutet, S.C.; Hebestreit, K.; Brunet, A. Single-Cell Transcriptomic Analysis Defines Heterogeneity and Transcriptional Dynamics in the Adult Neural Stem Cell Lineage. Cell Rep. 2017, 18, 777–790. [Google Scholar] [CrossRef] [PubMed]
- Jaraíz-Rodríguez, M.; Tabernero, M.D.; González-Tablas, M.; Otero, A.; Orfao, A.; Medina, J.M.; Tabernero, A. A Short Region of Connexin43 Reduces Human Glioma Stem Cell Migration, Invasion, and Survival through Src, PTEN, and FAK. Stem Cell Rep. 2017, 9, 451–463. [Google Scholar] [CrossRef]
- Shao, N.Y.; Wang, D.X.; Wang, Y.; Li, Y.; Zhang, Z.Q.; Jiang, Q.; Luo, W.; Cao, C. MicroRNA-29a-3p Downregulation Causes Gab1 Upregulation to Promote Glioma Cell Proliferation. Cell. Physiol. Biochem. 2018, 48, 450–460. [Google Scholar] [CrossRef]
- Zhen, Y.B.; Chen, X.F.; Yan, T.; Zhao, S.G. Expression of TAG1/APP signaling pathway in the proliferation and differentiation of glioma stem cells. Oncol. Lett. 2017, 14, 2137–2140. [Google Scholar] [CrossRef]
- Puca, F.; Tosti, N.; Federico, A.; Kuzay, Y.; Pepe, A.; Morlando, S.; Savarese, T.; D’Alessio, F.; Colamaio, M.; Sarnataro, D.; et al. HMGA1 negatively regulates NUMB expression at transcriptional and post transcriptional level in glioblastoma stem cells. Cell Cycle 2019, 18, 1446–1457. [Google Scholar] [CrossRef]
- Gouazé-Andersson, V.; Delmas, C.; Taurand, M.; Martinez-Gala, J.; Evrard, S.; Mazoyer, S.; Toulas, C.; Cohen-Jonathan-Moyal, E. FGFR1 induces glioblastoma radioresistance through the PLCγ/Hif1α pathway. Cancer Res. 2016, 76, 3036–3044. [Google Scholar] [CrossRef]
- Royet, A.; Broutier, L.; Coissieux, M.M.; Malleval, C.; Gadot, N.; Maillet, D.; Gratadou-Hupon, L.; Bernet, A.; Nony, P.; Treilleux, I.; et al. Ephrin-B3 supports glioblastoma growth by inhibiting apoptosis induced by the dependence receptor EphA4. Oncotarget 2017, 8, 23750–23759. [Google Scholar] [CrossRef]
- Huang, S.X.; Zhao, Z.Y.; Weng, G.H.; He, X.Y.; Wu, C.J.; Fu, C.Y.; Sui, Z.Y.; Ma, Y.S.; Liu, T. Upregulation of miR-181a suppresses the formation of glioblastoma stem cells by targeting the Notch2 oncogene and correlates with good prognosis in patients with glioblastoma multiforme. Biochem. Biophys. Res. Commun. 2017, 486, 1129–1136. [Google Scholar] [CrossRef]
- Kim, Y.W.; Kwon, C.; Liu, J.L.; Kim, S.H.; Kim, S. Cancer association study of aminoacyl-tRNA synthetase signaling network in glioblastoma. PLoS ONE 2012, 7, e40960. [Google Scholar] [CrossRef]
- Gao, W.Z.; Guo, L.M.; Xu, T.Q.; Yin, Y.H.; Jia, F. Identification of a multidimensional transcriptome signature for survival prediction of postoperative glioblastoma multiforme patients. J. Transl. Med. 2018, 16, 368. [Google Scholar] [CrossRef]
- Zhang, M.; Pan, Y.; Qi, X.; Liu, Y.; Dong, R.; Zheng, D.; Chang, Q.; Zhang, J.; Fang, W.; Zhong, Y. Identification of New Biomarkers Associated With IDH Mutation and Prognosis in Astrocytic Tumors Using NanoString nCounter Analysis System. Appl. Immunohistochem. Mol. Morphol. 2018, 26, 101–107. [Google Scholar] [CrossRef]
- Qin, W.; Rong, X.; Dong, J.; Yu, C.; Yang, J. miR-142 inhibits the migration and invasion of glioma by targeting Rac1. Oncol. Rep. 2017, 38, 1543–1550. [Google Scholar] [CrossRef]
- Liu, Y.Y.; Chen, M.B.; Cheng, L.; Zhang, Z.Q.; Yu, Z.Q.; Jiang, Q.; Chen, G.; Cao, C. microRNA-200a downregulation in human glioma leads to Galphai1 over-expression, Akt activation, and cell proliferation. Oncogene 2018, 37, 2890–2902. [Google Scholar] [CrossRef]
- Wang, X.; Prager, B.C.; Wu, Q.; Kim, L.J.Y.; Gimple, R.C.; Shi, Y.; Yang, K.; Morton, A.R.; Zhou, W.; Zhu, Z.; et al. Reciprocal Signaling between Glioblastoma Stem Cells and Differentiated Tumor Cells Promotes Malignant Progression. Cell Stem Cell 2018, 22, 514–528.e5. [Google Scholar] [CrossRef]
- Tseliou, M.; Al-Qahtani, A.; Alarifi, S.; Alkahtani, S.H.; Stournaras, C.; Sourvinos, G. The Role of RhoA, RhoB and RhoC GTPases in Cell Morphology, Proliferation and Migration in Human Cytomegalovirus (HCMV) Infected Glioblastoma Cells. Cell. Physiol. Biochem. 2016, 38, 94–109. [Google Scholar] [CrossRef]
- Wei, Y.; Wang, F.; Sang, B.; Xu, Z.; Yang, D. Activation of KRas-ERK1/2 signaling drives the initiation and progression of glioma by suppressing the acetylation of histone H4 at lysine 16. Life Sci. 2019, 225, 55–63. [Google Scholar] [CrossRef]
- Sun, M.Z.; Kim, J.M.; Oh, M.C.; Safaee, M.; Kaur, G.; Clark, A.J.; Bloch, O.; Ivan, M.E.; Kaur, R.; Oh, T.; et al. Na⁺/K⁺-ATPase β2-subunit (AMOG) expression abrogates invasion of glioblastoma-derived brain tumor-initiating cells. Neuro-Oncology 2013, 15, 1518–1531. [Google Scholar] [CrossRef]
- Doan, P.; Musa, A.; Candeias, N.R.; Emmert-Streib, F.; Yli-Harja, O.; Kandhavelu, M. Alkylaminophenol Induces G1/S Phase Cell Cycle Arrest in Glioblastoma Cells Through p53 and Cyclin-Dependent Kinase Signaling Pathway. Front. Pharmacol. 2019, 10, 330. [Google Scholar] [CrossRef]
- Matsuda, Y.; Ishiwata, T.; Yoshimura, H.; Hagio, M.; Arai, T. Inhibition of nestin suppresses stem cell phenotype of glioblastomas through the alteration of post-translational modification of heat shock protein HSPA8/HSC71. Cancer Lett. 2015, 357, 602–611. [Google Scholar] [CrossRef] [PubMed]
- Liang, J.; Zhang, X.L.; Li, S.; Xie, S.; Wang, W.-F.; Yu, R.-T. Ubiquitin-specific protease 22 promotes the proliferation, migration and invasion of glioma cells. Cancer Biomarkers 2018, 23, 381–389. [Google Scholar] [CrossRef]
- Yang, J.K.; Yang, J.P.; Tong, J.; Jing, S.Y.; Fan, B.; Wang, F.; Sun, G.Z.; Jiao, B.H. Exosomal miR-221 targets DNM3 to induce tumor progression and temozolomide resistance in glioma. J. Neuro-Oncol. 2017, 131, 255–265. [Google Scholar] [CrossRef] [PubMed]
- Modrek, A.S.; Prado, J.; Bready, D.; Dhaliwal, J.; Golub, D.; Placantonakis, D.G. Modeling Glioma with Human Embryonic Stem Cell-Derived Neural Lineages. Advanced Structural Safety Studies 2018, 227–237. [Google Scholar]
  
    
  
  
    Figure 1.
      The overall framework for criterion to explore the kernel differential subgraph (CKDS). KDS: kernel differential subgraph.
  
 
   Figure 1.
      The overall framework for criterion to explore the kernel differential subgraph (CKDS). KDS: kernel differential subgraph.
  
 
  
    
  
  
    Figure 2.
      2–4-node graphlets G0–G8 and their automorphism orbits0–orbits14 [
25].
  
 
 
   Figure 2.
      2–4-node graphlets G0–G8 and their automorphism orbits0–orbits14 [
25].
 
  
 
  
    
  
  
    Figure 3.
      Three-dimensional (3D) Surface Graph of the result of Dataset I. The x-axis and y-axis represent the value of a and b respectively, and the z-axis represents the value of evaluation indicator precision ().
  
 
   Figure 3.
      Three-dimensional (3D) Surface Graph of the result of Dataset I. The x-axis and y-axis represent the value of a and b respectively, and the z-axis represents the value of evaluation indicator precision ().
  
 
  
    
  
  
    Figure 4.
      The datasets and KDS of glioblastoma (GBM) and fetal human cortical neurons (FHCN). (a) The pre-treatment datasets of GBM and FHCN. (b) The KDS of GBM and FHCN. The bolded border indicates the genes with high topological differences. The genes marked in red are frequently occurring in Gene Ontology (GO) terms. The genes marked in blue are enriched in glioma pathway by KEGG enrichment analysis. The half blue half red nodes indicate that the genes occur frequently in GO terms and are enriched in glioma pathway by Kyoto Encyclopedia of Genes and Genomes (KEGG) enrichment analyses.
  
 
   Figure 4.
      The datasets and KDS of glioblastoma (GBM) and fetal human cortical neurons (FHCN). (a) The pre-treatment datasets of GBM and FHCN. (b) The KDS of GBM and FHCN. The bolded border indicates the genes with high topological differences. The genes marked in red are frequently occurring in Gene Ontology (GO) terms. The genes marked in blue are enriched in glioma pathway by KEGG enrichment analysis. The half blue half red nodes indicate that the genes occur frequently in GO terms and are enriched in glioma pathway by Kyoto Encyclopedia of Genes and Genomes (KEGG) enrichment analyses.
  
 
  
    
  
  
    Figure 5.
      The datasets and KDSs of neural differentiation. The pre-treatment datasets of Group A (a) and Group B (b). The KDSs of Group A (c) and Group B (d). In (c) and (d), the bolded border indicates the genes with high topological differences. The genes marked in red are frequently occurring in GO terms. The genes marked in blue are enriched in Glioma pathway by KEGG enrichment analyses. The half blue half red nodes indicate that the genes occur frequently in GO terms and are enriched in Glioma pathway by KEGG enrichment analyses.
  
 
   Figure 5.
      The datasets and KDSs of neural differentiation. The pre-treatment datasets of Group A (a) and Group B (b). The KDSs of Group A (c) and Group B (d). In (c) and (d), the bolded border indicates the genes with high topological differences. The genes marked in red are frequently occurring in GO terms. The genes marked in blue are enriched in Glioma pathway by KEGG enrichment analyses. The half blue half red nodes indicate that the genes occur frequently in GO terms and are enriched in Glioma pathway by KEGG enrichment analyses.
  
 
  
    
  
  
    Table 1.
    The evaluation indicators of three classical methods compared with CKDS. TKDS: Topology-based KDS; KDS-SMT: kernel differential subgraph-Steiner Minimal Tree.
  
 
  
      Table 1.
    The evaluation indicators of three classical methods compared with CKDS. TKDS: Topology-based KDS; KDS-SMT: kernel differential subgraph-Steiner Minimal Tree.
      
        |  | Methods | KDS-SMT | KDS-Floyd | TKDS | CKDS | 
|---|
| Indicators |  | 
|---|
| Accuracy | 87.51% | 81.30% | 83.72% | 88.86% | 
| Precision () | 0.684 | 0.793 | 0.797 | 0.871 | 
| Recall | 42.30% | 32.29% | 35.87% | 46.93% | 
| F1-Score | 0.523 | 0.459 | 0.495 | 0.610 | 
      
 
  
    
  
  
    Table 2.
    The biological functions, corresponding PubMed IDs and literatures for genes with large topological changes between GBM and FHCN.
  
 
  
      Table 2.
    The biological functions, corresponding PubMed IDs and literatures for genes with large topological changes between GBM and FHCN.
      
        | Symbol: Gene Name | Function Roles in GBM | PMID Reference | 
|---|
| TGFB1: transforming growth factor beta 1 | the oncogenic MSH6-CXCR4-TGFB1 feedback loop is a novel therapeutic target for GBM | 30867843 [39] | 
| HRAS: HRas proto-oncogene, GTPase | expression of oncogenic HRAS results in a malignant phenotype in glioma cell lines | 27834733 [40] | 
| NFKB1: nuclear factor kappa B subunit | increase glioma cancer risk | 30450997 [41] | 
| PML: promyelocytic leukemia | a PML/SLIT1 axis regulates sensitivity to the PML-targeting drug arsenic trioxide in primary GBM cells | 28700942 [42] | 
| MYD88: MYD88 innate immune signal transduction adaptor | divide GBM patient | 29168084 [43] | 
| ACTN1: actinin alpha 1 | influence the development of astrocytoma cells | 20156433 [44] | 
| CSF1: colony stimulating factor 1 | CSF1 signaling is oncogenic during gliomagenesis through a mechanism distinct from modulating GAM polarization status. | 27013192 [45] | 
| GAS6: growth arrest specific 6 | represent a potential new approach for glioma treatment | 18172262 [46] | 
      
 
  
    
  
  
    Table 3.
    The biological functions, corresponding PubMed IDs and literature references for enriched genes by GO enrichment analyses between GBM and FHCN.
  
 
  
      Table 3.
    The biological functions, corresponding PubMed IDs and literature references for enriched genes by GO enrichment analyses between GBM and FHCN.
      
        | Symbol: Gene name | Function roles in GBM | PMID Reference | 
|---|
| EGFR: Epidermal growth factor receptor | promote glioma growth and angiogenesis | 22139077 [47] | 
| DAXX: death domain associated protein | targeting telomerase and ATRX/DAXX inducing tumor senescence and apoptosis in the malignant glioma | 30625996 [48] | 
| ANXA1: Annexin A1 | enhance cancer growth and migration | 29263330 [49] | 
| ANXA2: Annexin A2 | affect the proliferation of human glioma cells through the STAT3 cyclin D1 pathway via direct interaction with STAT3 in U251 and U87 glioma cells | 31115554 [50] | 
| LYN: LYN proto-oncogene, Src family tyrosine kinase | facilitate glioblastoma cell survival under conditions of nutrient deprivation by promoting autophagy | 23936469 [51] | 
| HSPA1B: heat shock protein family A (Hsp70) member 1B | therapeutic targets for enhancing the efficacy of erlotinib against GBMs | 19301967 [52] | 
| EPHA3: EPH receptor A3 | a functional tumour-specific therapeutic target in glioblastoma | 30562956 [53] | 
| INSR: insulin receptor | activation of the InsR/IGF1R pathway confers resistance to EGFR inhibitors in EGFR-dependent glioblastoma through AKT regulation | 26561558 [54] | 
| TGFB1: transforming growth factor beta 1 | the oncogenic MSH6-CXCR4-TGFB1 feedback loop is a novel therapeutic target for GBM | 30867843 [39] | 
      
 
  
    
  
  
    Table 4.
    The biological functions, corresponding PubMed IDs and literatures for genes with large topological changes between activated neural stem cell (aNSC) and neural progenitor cells (NPC).
  
 
  
      Table 4.
    The biological functions, corresponding PubMed IDs and literatures for genes with large topological changes between activated neural stem cell (aNSC) and neural progenitor cells (NPC).
      
        | Symbol: Gene Name | Function Roles in GBM | PMID References | 
|---|
| Src: SRC proto-oncogene, non-receptor tyrosine kinase | Reduce human glioma stem cell migration, invasion, and survival | 28712848 [56] | 
| Egfr: Epidermal growth factor receptor | Promote glioma growth and angiogenesis | 22139077 [47] | 
| Gab1: GRB2 associated binding protein 1 | Promote glioma cell proliferation | 30016785 [57] | 
| App: amyloid beta precursor protein | Promote the proliferation of glioma cells to inhibit the differentiation of glioma cells | 28789439 [58] | 
| Numb: NUMB endocytic adaptor protein | Effective anti-cancer therapy | 31116627 [59] | 
| Plcg1: phospholipase C gamma 1 | Induce Glioblastoma Radioresistance | 26896280 [60] | 
| Efnb3: ephrin B3 | Support glioblastoma growth | 28423606 [61] | 
| Notch2: notch receptor 2 | Tumor biomarkers in GBM | 28389242 [62] | 
      
 
  
    
  
  
    Table 5.
    The biological functions, corresponding PubMed IDs and literatures for genes with large topological changes between NPC and astrocytes (Ast).
  
 
  
      Table 5.
    The biological functions, corresponding PubMed IDs and literatures for genes with large topological changes between NPC and astrocytes (Ast).
      
        | Symbol: Gene Name | Function Roles in GBM | PMID Reference | 
|---|
| Hsp90aa1: heat shock protein 90 alpha family class A member 1 | survival signatures in GBM | 22952576 [63] | 
| Eprs: glutamyl-prolyl-tRNA synthetase | the protein coding genes in GBM | 30572911 [64] | 
| Hsp90ab1: heat shock protein 90 alpha (cytosolic), class B member 1 | predict prognosis in astrocytic tumors | 27258564 [65] | 
      
 
  
    
  
  
    Table 6.
    The biological functions, corresponding PubMed IDs and literature references for enriched genes by GO enrichment analyses between aNSC and NPC.
  
 
  
      Table 6.
    The biological functions, corresponding PubMed IDs and literature references for enriched genes by GO enrichment analyses between aNSC and NPC.
      
        | Symbol: Gene Name | Function Roles in GBM | PMID Reference | 
|---|
| Pten: phosphatase and tensin homolog | Reduce human glioma stem cell migration, invasion, and survival | 28712848 [56] | 
| Egfr: Epidermal growth factor receptor | Promote glioma growth and angiogenesis | 22139077 [47] | 
| Rac1: Rac family small GTPase 1 | Inhibit the migration and invasion of glioma | 28714015 [66] | 
| Fgfr1: fibroblast growth factor receptor 1 | Induce Glioblastoma Radioresistance | 26896280 [60] | 
| Gnai1: G protein subunit alpha i1 | The growth of subcutaneous and orthotopic glioma xenografts | 29520106 [67] | 
| Ntrk2: neurotrophic tyrosine kinase, receptor, type 2 | Promote tumor growth | 29625067 [68] | 
| Rhob: ras homolog family member B | Differential implication of Rho GTPases in morphology, proliferation rate and motility of human glioblastoma cells | 26741994 [69] | 
| Kras: KRAS proto-oncogene, GTPase | Drive the initiation and progression of glioma | 30946839 [70] | 
      
 
  
    
  
  
    Table 7.
    The biological functions, corresponding PubMed IDs and literature references for enriched genes by GO enrichment analyses between NPC and Ast.
  
 
  
      Table 7.
    The biological functions, corresponding PubMed IDs and literature references for enriched genes by GO enrichment analyses between NPC and Ast.
      
        | Symbol: Gene Name | Function Roles in GBM | PMID Reference | 
|---|
| Hsp90aa1: heat shock protein 90 alpha family class A member 1 | Survival signatures in GBM | 30572911 [63] | 
| Hsp90ab1: heat shock protein 90 alpha (cytosolic), class B member 1 | predict prognosis in astrocytic tumors | 27258564 [65] | 
| Atp1b2: ATPase Na+/K+ transporting subunit beta 2 | Na⁺/K⁺-ATPase β2-subunit (AMOG) expression abrogates invasion of glioblastoma-derived brain tumor-initiating cells. | 23887941 [71] | 
| Trp53: tumor protein p53 | Induce G1/S phase cell cycle arrest in glioblastoma cells | 31001122 [72] | 
| Hspa8: heat shock protein family A (Hsp70) member 8 | Inhibition of nestin suppresses stem cell phenotype of glioblastomas | 25527454 [73] | 
| Usp22: ubiquitin specific peptidase 22 | Increase the abilities of proliferation, migration and invasion of glioma cells, and promote the growth and development of glioma | 30223389 [74] | 
| Atp1a2: ATPase, Na+/K+ transporting, alpha 2 polypeptide | Induce tumor progression and temozolomide resistance in glioma | 27837435 [75] | 
      
 
      
© 2020 by the authors. Licensee MDPI, Basel, Switzerland. This article is an open access article distributed under the terms and conditions of the Creative Commons Attribution (CC BY) license (http://creativecommons.org/licenses/by/4.0/).