CN111223523A - Gene regulation and control network construction method and system based on multi-time-lag causal entropy - Google Patents

Gene regulation and control network construction method and system based on multi-time-lag causal entropy Download PDF

Info

Publication number
CN111223523A
CN111223523A CN202010013036.9A CN202010013036A CN111223523A CN 111223523 A CN111223523 A CN 111223523A CN 202010013036 A CN202010013036 A CN 202010013036A CN 111223523 A CN111223523 A CN 111223523A
Authority
CN
China
Prior art keywords
gene
time
lag
under
entropy
Prior art date
Legal status (The legal status is an assumption and is not a legal conclusion. Google has not performed a legal analysis and makes no representation as to the accuracy of the status listed.)
Granted
Application number
CN202010013036.9A
Other languages
Chinese (zh)
Other versions
CN111223523B (en
Inventor
李敏
冯浩楠
郑瑞清
Current Assignee (The listed assignees may be inaccurate. Google has not performed a legal analysis and makes no representation or warranty as to the accuracy of the list.)
Central South University
Original Assignee
Central South University
Priority date (The priority date is an assumption and is not a legal conclusion. Google has not performed a legal analysis and makes no representation as to the accuracy of the date listed.)
Filing date
Publication date
Application filed by Central South University filed Critical Central South University
Priority to CN202010013036.9A priority Critical patent/CN111223523B/en
Publication of CN111223523A publication Critical patent/CN111223523A/en
Application granted granted Critical
Publication of CN111223523B publication Critical patent/CN111223523B/en
Active legal-status Critical Current
Anticipated expiration legal-status Critical

Links

Images

Classifications

    • GPHYSICS
    • G16INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR SPECIFIC APPLICATION FIELDS
    • G16BBIOINFORMATICS, i.e. INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR GENETIC OR PROTEIN-RELATED DATA PROCESSING IN COMPUTATIONAL MOLECULAR BIOLOGY
    • G16B20/00ICT specially adapted for functional genomics or proteomics, e.g. genotype-phenotype associations
    • GPHYSICS
    • G16INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR SPECIFIC APPLICATION FIELDS
    • G16BBIOINFORMATICS, i.e. INFORMATION AND COMMUNICATION TECHNOLOGY [ICT] SPECIALLY ADAPTED FOR GENETIC OR PROTEIN-RELATED DATA PROCESSING IN COMPUTATIONAL MOLECULAR BIOLOGY
    • G16B45/00ICT specially adapted for bioinformatics-related data visualisation, e.g. displaying of maps or networks

Landscapes

  • Physics & Mathematics (AREA)
  • Life Sciences & Earth Sciences (AREA)
  • Engineering & Computer Science (AREA)
  • Health & Medical Sciences (AREA)
  • Bioinformatics & Cheminformatics (AREA)
  • Theoretical Computer Science (AREA)
  • Evolutionary Biology (AREA)
  • Biophysics (AREA)
  • Spectroscopy & Molecular Physics (AREA)
  • Medical Informatics (AREA)
  • General Health & Medical Sciences (AREA)
  • Bioinformatics & Computational Biology (AREA)
  • Biotechnology (AREA)
  • Analytical Chemistry (AREA)
  • Proteomics, Peptides & Aminoacids (AREA)
  • Molecular Biology (AREA)
  • Genetics & Genomics (AREA)
  • Chemical & Material Sciences (AREA)
  • Data Mining & Analysis (AREA)
  • Management, Administration, Business Operations System, And Electronic Commerce (AREA)

Abstract

The invention discloses a gene regulation and control network construction method and a system based on multi-time-lag causal entropy, wherein input time sequence gene expression data is divided into time windows under different time lags; for gene expression data of t time slices, gene expression matrixes under t-tau time windows are respectively constructed, for each pair of genes, multi-time-lag transfer entropy of a target gene under the t time window and genes under the t-tau time windows before is calculated, a gene correlation matrix under multi-time lag is obtained, elements of the matrix represent the probability of edges between the genes, the edges of the matrix are clustered into two classes through k-means, low-probability edge clusters are filtered, multi-time-lag conditional transfer entropy under conditional genes is calculated for each remaining edge, indirectly regulated edges with the maximum causal entropy smaller than a threshold value are filtered, and a final network structure is obtained. The invention effectively improves the accuracy of inference.

Description

Gene regulation and control network construction method and system based on multi-time-lag causal entropy
Technical Field
The invention relates to the field of bioinformatics, and relates to a construction method of a complex biological network.
Background
In an organism, cells are the fundamental unit of all tissue structural and functional components. The DNA information of all cells in a living body is the same, but the cells of different tissues and organs have different differences, because a complex regulatory gene regulation mechanism exists in the cells, so that the expression of different cells presents a plurality of specificities. The mechanism controlling gene expression is collectively referred to as gene expression regulation. There are also differences in the way different organisms perform gene regulation. In prokaryotes, environmental stimulation plays a crucial role in the expression of genes, and prokaryotes are adapted to different environments by opening and closing the expression of a part of genes through contact with the external environment. Eukaryotic genes are more complex to regulate than prokaryotic genes. Regulation in eukaryotes is mainly influenced by hormones, the cell growth cycle, and environmental factors are greatly reduced. Specific features of gene regulation include (1) complex structure; (2) the regulation and control mode is changeable: there is both one-to-one gene regulation and one-to-many or many-to-one multifactorial regulation. (3) The types of the DNA gene are various, and the DNA gene can be participated in various types such as mRNA, protein, small molecules and the like. (4) The regulation relationship dynamically changes. Therefore, the gene regulation mechanism is one of the important bases for researching the growth and development rules and basic morphological structures of animals and plants
The computational construction of gene regulatory networks based on different types of gene expression data has become one of the important challenges in system biology. Common calculation methods for constructing gene regulatory networks cover a variety of fields of theory, including correlation analysis methods, bayesian networks, feature selection methods, and boolean networks. These determine the gene regulation relationship by analyzing the correlation between each two genes or analyzing the relationship of expression levels between genes by a modeling method, and finally construct a regulation network.
Correlation analysis to construct gene regulatory networks is one of the most intuitive methods. Researchers analyze the association between genes by using Pearson's correlation coefficient, mutual information, and the like. Among them, the most popular approach is gene regulatory network construction based on mutual information. Mutual information is more revealed than Pearson correlation coefficientThe non-linear regulation and control relationship between genes. Margolin et al propose the ARACNE algorithm, which uses Data Processing Inevaluation (DPI) to judge if there is any relation in a ternary relation group (X1, X2, X3)
Figure BDA0002356778930000011
Then the relationship I (X)1;X3)≤min[I(X1;X2),I(X2;X3)]. ARACNE calculates mutual information I for arbitrary paired genes, and uses threshold I0Margolin et al only think that I is greater than or equal to I0There is a regulatory relationship between the gene pairs. Meyer et al further proposed the MRNET algorithm based on ARACNE. The algorithm uses a strategy of maximum reservance/minimum redundacy (MRMR) and selects a node X by a greedy algorithmjThe difference Score between the node to be matched and the target node Y and the mutual information of the node to be matched and the other selected node set S is maximum. Patrick for a pair of nodes { Xi,XjUse the larger MRMR values as their weights. In further studies, Luo et al considered that the gene expression regulation relationship generally exceeds 3 genes, that is, there are generally two or more regulatory genes for the target gene T. Based on this hypothesis, they proposed a new algorithm MI3, which scores the target gene T and the two regulatory genes R1 and R2 through a correlation part and a coordination part, to find higher order interactions. Zhang et al sets a conditional mutual information and Path Consistency Algorithm (PCA), and proposes a network construction algorithm CMI-PCA. CMI-PCA adopts multivariate condition mutual information inspection to filter indirect regulation and control relation. Zhao et al propose a new mutual information estimation method PMI for the problem that the CMI-PCA has under-estimation in the calculation of the regulation relationship. The gene regulation network construction method based on mutual information breaks through the indirect regulation relationship.
A bayesian network is another common method for constructing a gene regulatory network. The Bayesian network quantifies the attributes of the biological directed network, and combines the methods of two aspects of graph theory and probability theory. The difficulties of the Bayesian network in the gene regulation network can be mainly classified into the structureLearning and parameter learning. Werhli and Husmeier integrate gene expression data and a priori knowledge of multiple sources. By constructing the energy function E (G) and combining Gibbs distribution as the learning of the Bayesian network structure, the accuracy of the Bayesian network construction is improved. At the same time, they also estimated the hyperparameters in different prior knowledge using markov chain Monte Carlo Method (MCMC). Qin et al added the similarity between the oncogene-specific genes to the previous knowledge and inferred the cell type-specific signaling network. In the algorithm process, the Bayesian network is established on a given normalized signal transmission network, a heuristic search algorithm is adopted, edges are added and deleted according to the similarity of the Ontology Fingerprint, and the conformity degree of the candidate model and the observation data is calculated to be used as a selection index. In the process of learning the Bayesian network structure, Qin adopts BIC as the selection of parameters, and uses Monte Carlo EM algorithm to infer the hidden state of nodes in the network, and further estimates candidate model parameters. Hill et al were inspired by "very few upstream regulatory factors" to consider the degree of introgression of genes in the network dmaxThe uncertainty of the network is effectively reduced by 4. The Hill method can achieve the AUC value of 0.82 when constructing the network in the yeast integrated network under the condition of giving a priori knowledge of the network structure, and is also extremely effective in breast cancer cell lines. Li et al propose a dynamic Bayesian algorithm MMHO-DBN combining a high-order time sequence model and Max-Min hill-bounding heuristic search. The MMHO-DBN adopts the improvement of a local search method, adopts Dynamic Max-Min Parent (DMMP) to obtain a father node set with great possibility, and effectively reduces the space of a candidate network structure.
At present, a plurality of gene regulation network construction methods are proposed, but the method is limited by the complexity of gene regulation, and the precision of the method still has a great space for improvement. Among them, the following problems mainly exist: (1) how to design an effective algorithm to filter indirect regulation and control relation among genes; (2) how to combine other biological information improves the precision of network construction.
Disclosure of Invention
The invention aims to solve the technical problem that aiming at the defects of the prior art, the invention provides a gene regulation and control network construction method based on multi-time-lag causal entropy, and the precision of network construction is improved.
In order to solve the technical problems, the technical scheme adopted by the invention is as follows: a gene regulation network construction method and system based on multi-time-lag causal entropy comprises the following steps:
1) dividing input time sequence gene expression data into different time windows according to the time lag tau;
2) respectively constructing time sequence gene expression matrixes under t-tau time windows and gene expression matrixes from t-tau to t-1 for gene expression data of t time slices after the windows are divided;
3) for each gene in the time sequence gene expression matrix under t-tau time windows, selecting an expression spectrum under the t window by a target gene, selecting an expression spectrum from the t-tau window to the t-1 time window by a regulatory factor, and calculating multi-time-lag transfer entropy between the genes to obtain a gene correlation matrix;
4) and for the fully-connected network of the gene correlation matrix, clustering edges into two types, filtering one type of edge with low probability value, calculating multi-time-lag causal entropy under genes with different conditions for each remaining edge, and filtering the indirectly-controlled edge with the maximum causal entropy lower than a threshold theta to obtain the final gene control network.
In the step 1), the regulation relationship can be identified more accurately by using multiple time delays, and the expression for dividing different time windows G tau according to the time lag tau is as follows:
Figure BDA0002356778930000031
wherein ,
Figure BDA0002356778930000032
representing the expression values of the gene N in the time window expression matrix G tau under the time window T of the sample M; t represents the gene expression vector under which moving time window; n represents the subscript of the gene, and N belongs to the number of the gene; m represents the index of the sample cell, and M is the sampleThe number of (2).
In step 3), in order to more accurately identify the regulation and control relationship under multiple time lags, the transfer entropy is popularized to a mode under multiple time lags, and the multiple time lags between genes transfer entropy TX→YThe calculation formula of (2) is as follows:
TX→Y=I(Yt,Xt-1:t-τ|Yt-1:t-τ)
=H(Yt|Yt-1:t-τ)-H(Yt|Yt-1:t-τ,Xt-1:t-τ);
wherein I(Yt,Xt-1:t-τ|Yt-1:t-τ) Represents Yt,Xt-1:t-τUnder the condition variable Yt-1:t-τConditional mutual information of (1):
Figure BDA0002356778930000041
wherein Px, y, z (x, y, z) represents a joint probability density, pz (z) represents a marginal probability density, and Px, z (x, z) represents a marginal probability density between variables x, z; xt-1:t-τRepresents the expression value of the gene x under the time window from t-1 to t-tau, H (. |) represents the conditional entropy:
Figure BDA0002356778930000042
where P (x, y) represents the joint probability and P (x) represents the marginal probability density.
In the step 4), in order to filter out the indirect regulation effect, a path consistency algorithm based on causal entropy is used, and the specific implementation process of filtering out the indirectly regulated edge with the maximum causal entropy lower than the threshold theta comprises the following steps:
1) for gene correlation matrix Gzero-orderFiltering the edges with low expression values, clustering the edges into two clusters according to k-means, and filtering the edges in the clusters with low probability values; elements in the gene correlation matrix represent the probability of regulatory relationships between genes;
2) filtering the indirectly regulated edges based on a path consistency algorithm, and filtering each edge (X, Y) in the filtered network if the edge (X, Y) existsThe edge (Y, Z) and the adjacent point Z of each edge of the edge (X, Z) are taken as the condition genes, and the causal entropy CE under the condition genes is calculatedX→Y|Z=I(Yt;Xt-1:t-τ|Zt-1:t-τ);
3) For the gene X, Y the conditional gene set K ∈ { K }1,K2,K3…KnFilter the maximum causal entropy max of multiple conditional genesZ∈K{CEX→Y|ZThe edge smaller than the threshold value theta.
The threshold value of the present application may be set to 0.03.
The invention also provides a gene regulation and control network construction system based on multi-time-lag causal entropy, which comprises the following steps:
an input unit for dividing input time series gene expression data into different time windows according to the time lag tau;
the gene expression matrix construction unit is used for respectively constructing time sequence gene expression matrixes under t-tau time windows and gene expression matrixes from t-tau to t-1 for the gene expression data of t time slices after the windows are divided;
the gene correlation matrix construction unit is used for selecting an expression spectrum under a t window for each gene in the time sequence gene expression matrix under the t-tau time windows, selecting the expression spectrum from the t-tau window to the t-1 time window by using a regulatory factor, and calculating the multi-time-lag transfer entropy between the genes to obtain a gene correlation matrix;
and the clustering unit is used for clustering the edges of the fully-connected network of the gene correlation matrix into two types, filtering one type of edge with low probability value, calculating the multi-time-lag causal entropy under different condition genes for each remaining edge, and filtering the indirectly-controlled edge with the maximum causal entropy lower than the threshold theta to obtain the final gene control network.
Compared with the prior art, the invention has the beneficial effects that: the method is suitable for the situation that the real time sequence gene expression data time slices are too few, can calculate the regulation and control relation of the genes under a plurality of time slices, filters the indirectly regulated edges through the conditional transfer entropy, and effectively improves the precision of network construction.
Drawings
FIG. 1 is a flow chart of the NIMCE of the present invention;
FIG. 2 is a graph comparing methods NIMCE and GENIE3, Jump3, fastBMA method based on PR curves and the area under them (AUPR);
FIG. 3 is a graph comparing the evaluation of methods NIMCE and GENIE3, Jump3, fastBMA method based on Recalll, Precision method.
Detailed Description
First, construction of time window gene expression matrix
Reading a time sequence gene table data file, wherein G represents a gene expression matrix, and an expression matrix G tau under a moving time window is represented as:
Figure BDA0002356778930000051
wherein ,
Figure BDA0002356778930000052
representing the expression values of the gene N in the time window expression matrix G tau under the time window T of the sample M; t represents the gene expression vector under which moving time window; n represents the index of the gene (N.epsilon.number of genes) and M represents the index of the sample cell (M.epsilon.number of samples).
Second, construct the gene correlation matrix
For each pair of genes, selecting an expression spectrum under a t window from a target gene, selecting an expression spectrum from a t-tau window to a t-1 time window from a regulatory factor, and calculating the multi-time-lag transfer entropy between the regulatory factor and the target gene:
Figure BDA0002356778930000061
wherein I(Yt,Xt-1:t-τ|Yt-1:t-τ) Represents Yt,Xt-1:t-τUnder the condition variable Yt-1:t-τConditional mutual information of (1):
Figure BDA0002356778930000062
where Px, y, z (x, y, z) represents the joint probability density, pz (z) represents the marginal probability density, and Px, z (x, z) represents the marginal probability density between the variables x, z.
Xt-1:t-τThe expression value of the gene x under the time window from t-1 to t-tau is represented, the expression of the gene y is similar, and H (. |) represents the conditional entropy:
Figure BDA0002356778930000063
where P (x, y) represents the joint probability and P (x) represents the marginal probability density.
In NIMCE, to efficiently calculate the distribution of probabilities in equation (2), we calculate the probability density of continuous variables using Kernel Density Estimation (KDE):
Figure BDA0002356778930000064
wherein XpRepresents Xt-1:t-τ,YpRepresents Yt-1:t-τWhere L ═ M (T- τ) denotes the number of samples in the time shift matrix, fh(x) Is a kernel density function defined as follows:
Figure BDA0002356778930000065
where h denotes the size of the baseband and K is a kernel function.
Third, filtering the indirectly regulated and controlled edge
For gene correlation matrix Gzero-orderElements in the matrix represent the probability of the existence of regulation and control relation between genes, edges are clustered into two clusters according to k-means, and the edges in the clusters with low probability values are filtered;
filtering the indirectly regulated edges based on a path consistency algorithm, regarding each edge (X, Y) in the filtered network, if the edge (Y, Z) exists and the adjacent point Z of the edge (X, Z) to each edge, as a conditional gene, and calculating the causal entropy CE under the conditional geneX→Y|Z=I(Yt;Xt-1:t-τ|Zt-1:t-τ);
For the gene X, Y the conditional gene set K ∈ { K }1,K2,K3…KnFilter the maximum causal entropy max among multiple conditional genesZ∈K{CEx→Y|zThe edge smaller than the threshold θ (override parameter set by human, default 0.03).
Fourth, experimental verification
To validate the method of the invention, we performed tests on 5 simulation data generated by GeneNetWave and compared and analyzed with GENIE3 based on random forest and Jump3 based on tree method and dynamic bayesian fastBMA. The GeneNetWave dataset was extracted from each subnet generated by E-coli or cerevisiae gene regulation network time series perturbation data for DREAM4 challenges. We generated 5 datasets using GNW, where each dataset contained 50 genes, each sample contained 10 samples, for a total of 21 time points of time expression data.
In order to evaluate the continuity and accuracy of the inference results, several indicators of AUPR value and Recall, Precision value were used for comparison. The AUPR value is the area under the line of the PR curve, the Recall value calculation formula is the ratio of the predicted correct edge number to the real directed edge number, the Precision value calculation formula is the ratio of the predicted correct edge number to the predicted edge number, and the AUPR value, Recall and Precision value are shown in FIG. 2 and FIG. 3 respectively.
As can be seen from fig. 2 and 3, our method outperforms other methods in terms of Precision values, whether based on the values of AUPR or Recall, under different samples. It can be seen that our proposed method NIMCE has good stability. Experiments show that under the condition of large network scale, time complexity is exponentially increased and basically cannot be calculated, and the NIMCE method can still obtain results in a short time.

Claims (6)

1. A gene regulation network construction method based on multi-time-lag causal entropy is characterized by comprising the following steps:
1) dividing input time sequence gene expression data into different time windows according to the time lag tau;
2) respectively constructing time sequence gene expression matrixes under t-tau time windows and gene expression matrixes from t-tau to t-1 for gene expression data of t time slices after the windows are divided;
3) for each gene in the time sequence gene expression matrix under t-tau time windows, selecting an expression spectrum under the t window by a target gene, selecting an expression spectrum from the t-tau window to the t-1 time window by a regulatory factor, and calculating multi-time-lag transfer entropy between the genes to obtain a gene correlation matrix;
4) and for the fully-connected network of the gene correlation matrix, clustering edges into two types, filtering one type of edge with low probability value, calculating multi-time-lag causal entropy under genes with different conditions for each remaining edge, and filtering the indirectly-controlled edge with the maximum causal entropy lower than a threshold theta to obtain the final gene control network.
2. The method for constructing the gene regulatory network based on the multi-time-lag causal entropy as claimed in claim 1, wherein in step 1), the expression for dividing different time windows G τ according to the time lag τ is as follows:
Figure FDA0002356778920000011
wherein ,
Figure FDA0002356778920000012
representing the expression values of the gene N in the time window expression matrix G tau under the time window T of the sample M; t represents the gene expression vector under which moving time window; n represents the subscript N of the gene belongs to the number of the genes; m represents the subscript M ∈ number of sample cells.
3. The method for constructing the gene regulatory network based on the multi-lag causal entropy as claimed in claim 1, wherein in the step 3), the multi-lag transition entropy T between the genes isX→YThe calculation formula of (2) is as follows:
TX→Y=I(Yt,Xt-1:t-τ|Yt-1:t-τ)
=H(Yt|Yt-1:t-τ)-H(Yt|Yt-1::t-τ,Xt-1:t-τ);
wherein I(Yt,Xt-1:t-τ|Yt-1:t-τ) Represents Yt,Xt-1:t-τUnder the condition variable Yt-1:t-τConditional mutual information of (1):
Figure FDA0002356778920000021
wherein Px, y, z (x, y, z) represents a joint probability density, pz (z) represents a marginal probability density, and Px, z (x, z) represents a marginal probability density between variables x, z;
Xt-1:t-τrepresents the expression value of the gene x under the time window from t-1 to t-tau, H (. |) represents the conditional entropy:
Figure FDA0002356778920000022
where P (x, y) represents the joint probability and P (x) represents the marginal probability density.
4. The method for constructing the gene regulatory network based on the multi-lag causal entropy as claimed in claim 1, wherein the specific implementation process of filtering out the indirectly regulated edges with the maximum causal entropy lower than the threshold θ in the step 4) comprises:
1) for gene correlation matrix Gzero-orderFiltering the edges with low expression values, clustering the edges into two clusters according to k-means, and filtering the edges in the clusters with low probability values; elements in the gene correlation matrix represent the probability of regulatory relationships between genes;
2) filtering the indirectly regulated edges based on a path consistency algorithm, regarding each edge (X, Y) existing in the filtered network, and if the edge (Y, Z) exists and the adjacent point Z existing on each edge by the edge (X, Z), taking the adjacent point Z as a condition gene, and calculating the conditionCausal entropy CE under genesX→Y|Z=I(Yt;Xt-1:t-τ|Zt-1:t-τ);
3) For the gene X, Y the conditional gene set K ∈ { K }1,K2,K3…KnFilter the maximum causal entropy max of multiple conditional genesZ∈k{CEX→Y|ZThe edge smaller than the threshold value theta.
5. The method for constructing the gene regulatory network based on the multi-lag causal entropy as claimed in claim 1, wherein the threshold is 0.03.
6. A gene regulation and control network construction system based on multi-time-lag causal entropy is characterized by comprising the following steps:
an input unit for dividing input time series gene expression data into different time windows according to the time lag tau;
the gene expression matrix construction unit is used for respectively constructing time sequence gene expression matrixes under t-tau time windows and gene expression matrixes from t-tau to t-1 for the gene expression data of t time slices after the windows are divided;
the gene correlation matrix construction unit is used for selecting an expression spectrum under a t window for each gene in the time sequence gene expression matrix under the t-tau time windows, selecting the expression spectrum from the t-tau window to the t-1 time window by using a regulatory factor, and calculating the multi-time-lag transfer entropy between the genes to obtain a gene correlation matrix;
and the clustering unit is used for clustering the edges of the fully-connected network of the gene correlation matrix into two types, filtering one type of edge with low probability value, calculating the multi-time-lag causal entropy under different condition genes for each remaining edge, and filtering the indirectly-controlled edge with the maximum causal entropy lower than the threshold theta to obtain the final gene control network.
CN202010013036.9A 2020-01-06 2020-01-06 Gene regulation network construction method and system based on multi-time-lag causal entropy Active CN111223523B (en)

Priority Applications (1)

Application Number Priority Date Filing Date Title
CN202010013036.9A CN111223523B (en) 2020-01-06 2020-01-06 Gene regulation network construction method and system based on multi-time-lag causal entropy

Applications Claiming Priority (1)

Application Number Priority Date Filing Date Title
CN202010013036.9A CN111223523B (en) 2020-01-06 2020-01-06 Gene regulation network construction method and system based on multi-time-lag causal entropy

Publications (2)

Publication Number Publication Date
CN111223523A true CN111223523A (en) 2020-06-02
CN111223523B CN111223523B (en) 2023-10-03

Family

ID=70811155

Family Applications (1)

Application Number Title Priority Date Filing Date
CN202010013036.9A Active CN111223523B (en) 2020-01-06 2020-01-06 Gene regulation network construction method and system based on multi-time-lag causal entropy

Country Status (1)

Country Link
CN (1) CN111223523B (en)

Cited By (3)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
CN113610760A (en) * 2021-07-05 2021-11-05 河海大学 Cell image segmentation and tracing method based on U-shaped residual error neural network
CN113889180A (en) * 2021-09-30 2022-01-04 山东大学 Biomarker identification method and system based on dynamic network entropy
CN114925837A (en) * 2022-03-23 2022-08-19 华中农业大学 Gene regulation and control network construction method based on mixed entropy optimization mutual information

Citations (4)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
JP2003058549A (en) * 2001-08-21 2003-02-28 Mamoru Kato Computer readable recording medium with program recorded thereon for estimating control relation between genes from gene expression quantity data and gene arrangement data
US20050256652A1 (en) * 2004-05-16 2005-11-17 Sai-Ping Li Reconstruction of gene networks from time-series microarray data
CN108491686A (en) * 2018-03-30 2018-09-04 中南大学 A kind of gene regulatory network construction method based on two-way XGBoost
KR20190054386A (en) * 2017-11-13 2019-05-22 한양대학교 산학협력단 Genome analysis method based on modularization

Patent Citations (4)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
JP2003058549A (en) * 2001-08-21 2003-02-28 Mamoru Kato Computer readable recording medium with program recorded thereon for estimating control relation between genes from gene expression quantity data and gene arrangement data
US20050256652A1 (en) * 2004-05-16 2005-11-17 Sai-Ping Li Reconstruction of gene networks from time-series microarray data
KR20190054386A (en) * 2017-11-13 2019-05-22 한양대학교 산학협력단 Genome analysis method based on modularization
CN108491686A (en) * 2018-03-30 2018-09-04 中南大学 A kind of gene regulatory network construction method based on two-way XGBoost

Non-Patent Citations (6)

* Cited by examiner, † Cited by third party
Title
BOR-SEN CHEN ET AL.: "On the interplay between entropy and robustness of gene regulatory networks", 《ENTROPY IN GENETICS AND COMPUTATIONAL BIOLOGY》 *
JUAN CAMILO CASTRO ET AL.: "Gene regulatory networks on transfer entropy (GRNTE): a novel approach to reconstruct gene regulatory interactions applied to a case study for the plant pathogen phytophthora infestans", 《THEORETICAL BIOLOGY AND MEDICAL MODELLING》 *
XIANG CHEN ET AL.: "A novel method of gene regulatory network structure inference from gene knock-out expression data", vol. 24, pages 446 - 455 *
XIUJUN ZHANG ET AL.: "Inferring gene regulatory networks from gene expression data by path consistency algorithm based on conditional mutual information", vol. 28, pages 98 - 104 *
王开军;张军英;赵峰;张宏怡;: "几何模式动态贝叶斯网络推理基因调控网络", 西安电子科技大学学报, no. 06 *
王文杰 等: "基因组学数据的网络构建与分析方法", vol. 34, pages 177 - 180 *

Cited By (6)

* Cited by examiner, † Cited by third party
Publication number Priority date Publication date Assignee Title
CN113610760A (en) * 2021-07-05 2021-11-05 河海大学 Cell image segmentation and tracing method based on U-shaped residual error neural network
CN113610760B (en) * 2021-07-05 2024-03-12 河海大学 Cell image segmentation tracing method based on U-shaped residual neural network
CN113889180A (en) * 2021-09-30 2022-01-04 山东大学 Biomarker identification method and system based on dynamic network entropy
CN113889180B (en) * 2021-09-30 2024-05-24 山东大学 Biomarker identification method and system based on dynamic network entropy
CN114925837A (en) * 2022-03-23 2022-08-19 华中农业大学 Gene regulation and control network construction method based on mixed entropy optimization mutual information
CN114925837B (en) * 2022-03-23 2024-04-16 华中农业大学 Gene regulation network construction method based on mixed entropy optimization mutual information

Also Published As

Publication number Publication date
CN111223523B (en) 2023-10-03

Similar Documents

Publication Publication Date Title
Egrioglu et al. Fuzzy time series forecasting with a novel hybrid approach combining fuzzy c-means and neural networks
Zhou et al. A Bayesian connectivity-based approach to constructing probabilistic gene regulatory networks
CN111223523A (en) Gene regulation and control network construction method and system based on multi-time-lag causal entropy
Maraziotis A semi-supervised fuzzy clustering algorithm applied to gene expression data
Chen et al. Inferring causal networks using fuzzy cognitive maps and evolutionary algorithms with application to gene regulatory network reconstruction
Bahrepour et al. An adaptive ordered fuzzy time series with application to FOREX
Wang et al. Learning large-scale fuzzy cognitive maps using an evolutionary many-task algorithm
Guo et al. Low dimensional mid-term chaotic time series prediction by delay parameterized method
CN108491686B (en) Bidirectional XGboost-based gene regulation and control network construction method
Pan et al. Multi-objective optimization method for learning thresholds in a decision-theoretic rough set model
Fu et al. An improved multi-objective marine predator algorithm for gene selection in classification of cancer microarray data
Afshar et al. Presenting a new multiclass classifier based on learning automata
Ahammad Microarray Cancer Classification with Stacked Classifier in Machine Learning Integrated Grid L1-Regulated Feature Selection
Huang et al. Identification of fuzzy inference systems using a multi-objective space search algorithm and information granulation
Bas et al. A fuzzy time series forecasting method based on operation of union and feed forward artificial neural network
Qu et al. Dynamic Bayesian network modeling based on structure prediction for gene regulatory network
Örkçü et al. A hybrid applied optimization algorithm for training multi-layer neural networks in data classification
Chrisman et al. Incorporating biological knowledge into evaluation of causal regulatory hypotheses
KohbalanMoorthy et al. An Evaluation of Machine Learning Algorithms for Missing Values Imputation
Cheng et al. An association-based evolutionary ensemble method of variable selection
Geurts et al. An introduction to machine learning
Zhoua et al. Low-level interpretability and high-level interpretability: a unified view of data-driven interpretable fuzzy system modeling
Shamami et al. Community Detection on a Modified Adjacency Matrix: A Novel Network Approach in Drug-Drug Interaction
Xiao Network-based approaches for multi-omic data integration
Yooseph et al. Variational approximation-based model selection for microbial network inference

Legal Events

Date Code Title Description
PB01 Publication
PB01 Publication
SE01 Entry into force of request for substantive examination
SE01 Entry into force of request for substantive examination
GR01 Patent grant
GR01 Patent grant