Abstract
The complexity of biological systems is encoded in gene regulatory networks. Unravelling this intricate web is a fundamental step in understanding the mechanisms of life and eventually developing efficient therapies to treat and cure diseases. The major obstacle in inferring gene regulatory networks is the lack of data. While time series data are nowadays widely available, they are typically noisy, with low sampling frequency and overall small number of samples. This paper develops a method called BINGO to specifically deal with these issues. Benchmarked with both real and simulated time-series data covering many different gene regulatory networks, BINGO clearly and consistently outperforms state-of-the-art methods. The novelty of BINGO lies in a nonparametric approach featuring statistical sampling of continuous gene expression profiles. BINGO’s superior performance and ease of use, even by non-specialists, make gene regulatory network inference available to any researcher, helping to decipher the complex mechanisms of life.
Subject terms: Bayesian inference, Differential equations, Dynamical systems, Nonlinear dynamics
Gene regulatory network inference is a topical problem in systems biology. Here, the authors presents BINGO, a powerful method for network inference from time series data.
Introduction
Cellular functions are controlled by the mechanism of gene expression, and the regulatory interconnection of genes. Knowledge of the regulatory structure enables understanding of biological mechanisms, and can, for example, lead to discoveries of new potential targets for drugs. Interactions between genes are typically represented as a gene regulatory network (GRN) whose nodes correspond to different genes, and a directed edge denotes a direct causal effect of some gene on another gene. The usual research aim is to infer the network topology from given gene expression data. Classically, GRN inference has been based on analysing steady-state data corresponding to gene knockout experiments, where one gene is silenced and changes in the steady-state expressions of other genes are observed. However, carrying out knockout experiments on a high number of genes is costly and technically infeasible. Moreover, it can be difficult to know if the system really is in a steady state when it is measured. By contrast, methods that infer GRNs from time series data can infer the networks on a more global level using data from few experiments. Therefore, GRN inference from time series data has gained more and more attention recently1–5.
Modelling dynamical systems from time series data are a problem with long history, in particular in the fields of mechanical, electrical, and control engineering. Inference of GRNs, however, adds further modelling challenges since data collection is expensive and technically demanding. Typically gene expression data have low sampling rates and relatively small amount of data. Moreover, GRNs have a high number of genes with complex, nonlinear regulatory mechanisms.
Several GRN inference problems, from different types of data, have been posed as competitive challenges by the "Dialogue for Reverse Engineering Assessments and Methods” (DREAM) project2,6. In addition, different methods have been compared in review articles1,2. Many different approaches have been taken to solve the problem, such as graphical models7, Bayesian network models8, information theory methods9,10, neural models5, and so on. The main focus of this article is on methods that are based on fitting an ordinary differential equation (ODE) model to the observed gene expression time series data.
Most ODE-based methods transform the system identification problem into an input–output regression problem where the inputs are the measured gene expression values and outputs are their derivatives that are estimated from the data. Derivative estimation can be based on simple difference approximation3,4,11,12, spline fitting13, Gaussian process fitting14,15, or regularised differentiation16,17. The regression problem is then solved by linear methods13, fitting mechanistic functions12,15, or a user-defined library of nonlinear functions4,16,18,19. Also nonparametric machine learning techniques have been used, such as random forest3 and Gaussian process regression11,14,20. A method based on Gaussian process regression, called “Causal structure identification” (CSI)14,20 was the best performer in a comparison study for network inference from time series data1.
Another ODE-based approach is to introduce a simple enough model class, from which trajectories can be directly simulated and compared to the measured data. Such strategy does not suffer badly from the low sampling rate, but the model class cannot be too complex, and it might be too restrictive to capture the behaviour of the real system. Linear dynamics have been proposed together with a Kalman filter state estimation scheme21. The winner of the DREAM4 in silico network inference challenge was a method called “Petri nets with fuzzy logic” (PNFL)22, whose model class consists of fuzzy membership functions.
This article presents BINGO (Bayesian Inference of Networks using Gaussian prOcess dynamical models). The novelty of BINGO is the introduction of statistical trajectory sampling. This enables the use of a flexible nonparametric approach for modelling the nonlinear ODE on continuous gene expression trajectories. BINGO is based on modelling gene expression with a nonlinear stochastic differential equation where the dynamics function (or drift function), is modelled as a Gaussian process. This defines gene expression as a stochastic process, whose realisations can be sampled using Markov chain Monte Carlo (MCMC) techniques. The key to overcome low sampling frequency is to sample the trajectory also between measurement times. The method pipeline is illustrated in Fig. 1. The Gaussian process framework is very flexible, which enables capturing complex nonlinear regulations between genes. Overfitting is avoided by integrating out all hyperparameters in the model, and concentrating solely on the network topologies, that are given a sparsity promoting prior.
Fig. 1. The pipeline of BINGO.
a BINGO can utilise time series data originating from any experimental technique. b A proposal trajectory sample is drawn by perturbing slightly the current sample x(l). The proposal is then accepted () or rejected (x(l+1) = x(l)) based on the Metropolis–Hastings acceptance ratio. The GRN topology proposal is constructed by adding or removing one link to/from the current topology S(l). c Output of BINGO is a confidence matrix of posterior probabilities for the existence of links.
While BINGO is not the first GRN inference method to utilise Gaussian processes to model the dynamics function in an ODE model, the existing approaches11,14 treat the problem as an input–output regression problem, with gene expression derivatives estimated directly from the time series data. This approach yields a probability distribution for the derivatives, whereas we obtain a probability distribution for the continuous gene expression trajectories. This allows by-passing the derivative estimation, which can be a serious source of errors when the sampling rate is low.
BINGO is validated by comparing it with state-of-the-art network inference methods using data from the DREAM4 in silico network inference challenge2,23,24. Moreover, the effects of sampling frequency and process noise are studied by applying the method to simulated data of the circadian clock of Arabidopsis thaliana25. Finally, BINGO’s performance on real experimental data is demonstrated by applying it to a dataset from the synthetic network IRMA26, and by using it on drug target identification. BINGO outperforms state-of-the-art network inference methods in inference from time series data.
Results
Gene expression modelled with differential equations
Gene expression time series data Y = {y0, …, ym} are modelled as samples from a continuous trajectory,
| 1 | 
where vj represents measurement noise. The continuous trajectory is assumed to satisfy a nonlinear stochastic differential equation
| 2 | 
where w is some driving process noise. Here, x is an -valued function, and thus also f is vector-valued,
| 3 | 
If function fi depends on xj, in the corresponding GRN there is a link from gene j to gene i. The task in GRN inference is to discover this regulatory interconnection structure between variables.
BINGO is based on a continuous-time version of the so-called Gaussian process dynamical model (GPDM). Essentially, the dynamics function f in Eq. (2) is modelled as a Gaussian process with some covariance function27. This defines x as a stochastic process with probability distribution p(x∣θ), where θ denotes hyperparameters of the Gaussian process—including the underlying GRN topology. Trajectory realisations from the conditional probability distribution
| 4 | 
can be sampled using MCMC techniques. Here p(Y∣x, θ) is the measurement model arising from Eq. (1). This trajectory sampling can be regarded as statistical interpolation where the trajectories are required to be consistent with both the measured data and the underlying dynamical system. No additional information is imputed in generating trajectory samples. The decoupling of the trajectory x and the measurements Y in Eq. (4) enable easy treatment of irregularities in time series data, such as missing measurements and non-constant sampling frequency.
GPDM for network inference
The discrete-time GPDM28 (a.k.a. Gaussian process state space model29,30) is based on GP latent variable models31. It is an effective tool for analysing time series data produced by an unknown dynamical system, or in the case the system is somehow too complicated to be presented using classical modelling techniques. In the original paper28, the method was used for human motion tracking from video data. Motion tracking problems remain the primary use of GPDMs32,33, but other types of applications have emerged as well, such as speech analysis34, traffic flow prediction35, and electric load prediction36. BINGO is based on continuous-time GPDM, which is introduced in this article, and some theory of GPDMs is presented in Supplementary Notes 1–3.
A Gaussian process f is a stochastic process, that is, a function whose values at any given set of input points form a random variable. Gaussian processes can be seen as a generalisation of normally distributed random variables. A Gaussian process is defined on some index set Ξ so that for any finite collection , the vector is normally distributed. Just like in the finite-dimensional case, properties of a Gaussian process are completely comprised in a mean function , and a covariance function k(ξ1, ξ2) = Cov(f(ξ1), f(ξ2)). Then it holds that
| 5 | 
where and is an N × N matrix whose element (i, j) is k(ξi, ξj).
Given noisy samples ηj = f(ξj) + vj, for j = 1, …, N with , the value f(ξ) at a generic point ξ can be approximated with the conditional expectation, which can be expressed analytically
| 6 | 
This is the basis of Gaussian process regression which is extensively used in nonlinear regression problems in the field of machine learning27. Its popularity is based on its analytical tractability and solid roots in probability theory. For example, it is possible to obtain confidence intervals for predictions of GP regression. In GPDM, thanks to the analytical tractability of the GP framework, it is possible to obtain the probability distribution p(x∣θ) for solutions of the stochastic differential Eq. (2), which is a vital component of BINGO.
The GP framework can handle combinatorial effects, meaning nonlinearities that cannot be decomposed into f(x1, x2) = f1(x1) + f2(x2). This is an important property for modelling a chemical system—such as gene expression—where reactions can happen due to combined effects of reactant species. For example, the dynamics corresponding to a chemical reaction x1 + x2 → x3 cannot be modelled by .
In a classical variable selection problem from input–output data ηj = f(ξj) + vj, for j = 1, …, N, where , the task is to find out which components of ξ does the function f depend on. In the GP framework, variable selection can be done by a technique known as “automatic relevance determination”37,38, based on estimating the hyperparameters of the covariance function of f. For BINGO, we have chosen the squared exponential covariance function for each component fi:
| 7 | 
The hyperparameters βi,j ≥ 0 are known as inverse length scales, since corresponds to a distance that has to be moved in the direction of the jth coordinate for the value of function fi to change considerably. If βi,j = 0, then fi is constant in the corresponding direction. The mean function for fi is mi(x) = bi − aixi where ai and bi are regarded as nonnegative hyperparameters corresponding to mRNA degradation and basal transcription, respectively.
Network inference using BINGO is based on Bayesian estimation of parameters βi,j: p(θ∣Y) ∝ p(Y, θ) = ∫ p(Y, x, θ)dx = ∫ p(Y∣x, θ)p(x∣θ)p(θ)dx. Again θ consists of all hyperparameters in the method, including the interesting parameters βi,j. The integral with respect to the continuous trajectory x is done by sampling trajectories from the distribution p(Y∣x, θ)p(x∣θ), as described above. Also, all the hyperparameters are sampled, including βi,j that are given zero-preferring priors by using an indicator matrix S, which is the adjacency matrix of the corresponding directed graph structure. BINGO’s output is the average of the indicator samples (see Fig. 1). The elements of this matrix converge to posterior probabilities of the existence of corresponding links in the GRN—of course subjected to the validity of the underlying (implicit) assumptions. BINGO can be applied on time series data of gene expression produced by any experimental technique.
Benchmarking
BINGO has been benchmarked using data from the DREAM4 in silico network challenge, simulated data from the circadian clock of the plant Arabidopsis thaliana with different sampling rates and process noise levels, and the IRMA in vivo dataset. The DREAM4 and IRMA data represent systems’ adaptation to external perturbations, whereas the circadian clock is a naturally dynamic, oscillating system. In all benchmark experiments, BINGO is compared with four recent methods, dynGENIE33, iCheMA15, ARNI4, and GRNTE9 (see Supplementary Note 9 on the implementation of ARNI and dynGENIE3). They are designed for inference from time series data. In addition, DREAM4 and IRMA datasets have been used in other benchmarking studies, and some results found in the literature and the best performers in the DREAM4 challenge have been included in the comparison. Standard classifier scores are used for the comparison, namely the area under the receiver operating characteristic curve (AUROC) and the area under the precision-recall curve (AUPR). The AUROC score gives equal weight to all predictions, whereas the AUPR is more sensitive to the correctness of high confidence predictions. GRNs are typically sparse, causing a class imbalance between true and false links. The low confidence predictions therefore contain a high number of false positives, rendering the predictions with low confidence less important. The AUPR should therefore be considered as the primary performance metric. Self-regulation is always excluded in the computation of the AUROC and AUPR scores as in the DREAM4 challenge. Aggregated results of the benchmark cases are illustrated in Fig. 2.
Fig. 2. Results on benchmark experiments.
a The DREAM results consist of average values over the five networks using the time series data only. b, c The results on the circadian clock of Arabidopsis thaliana consist of averages over ten replicates. The results for different sampling rates (1 h/2 h/4 h) are shown separately. d In the IRMA results, both full data (F) and averaged data (A) results are shown separately.
DREAM4 in silico network challenge: The challenge consists of ten network inference tasks—five tasks with network size 10 and five with size 1002,23,24,39. The simulated data consist of five time series for each 10-gene network and ten time series for each 100-gene network. These time series simulate microarray experiments where static perturbations have been applied on some genes for the first half of the recording time. The time series illustrate the system’s adaptation to the perturbation, and its relaxation when the perturbation is removed. Each time series consists of 21 time points. In addition, steady-state values are provided as well as gene knockout and knockdown data corresponding to each gene. The 10-gene challenge provides multifactorial data, corresponding to steady-state values under mild perturbations on the basal transcription rate. This corresponds to data collected from different cells, for example.
BINGO is first compared with the aforementioned methods using the time series data, and then with the challenge best performers using all available data. The use of steady-state data from knockout/-down experiments by BINGO is discussed in Supplementary Note 5. The best performer in a recent comparison of network inference methods from time series data1 (in terms of average AUPR value) was a method called “Causal Structure Identification”14,20, which is also based on Gaussian process regression. Its discrete-time version is included in the comparison, since its performance was better. The 10-gene challenge winner was “Petri Nets with Fuzzy Logic”22. The 100-gene challenge winner40 used only the knockout data. A similar method, the “median-corrected Z-score” (MCZ)41, achieved the second highest score in the 100-gene challenge. Any method inferring networks from time series data can be combined with a method inferring GRNs from steady-state data41, such as the MCZ. Unfortunately, the MCZ requires knockouts or knockdowns of all genes, which can hardly be expected in a real experiment. Nevertheless, the combinations dynGENIE3*MCZ and BINGO*MCZ are included in the full data comparison. The scores for the combined methods are the products of the individual scores, favouring links that score high in both methods. It should be noted that BINGO (as well as the PNFL) can utilise also partial knockout data together with time series data. The results on DREAM4 data are summarised in Supplementary Table 4.
BINGO consistently outperforms other methods by a large margin (with the exception of network 3) in GRN inference from time series data in the 10-gene case. When using all data from the challenge, BINGO scores slightly higher (average AUPR) than the DREAM4 10-gene challenge winner PNFL. The average scores are very close to each other but in the different networks there are some rather significant differences. BINGO reaches a fairly high AUPR in network 2, which seemed to be very difficult for all challenge participants. The best AUPR for network 2 among the challenge participants was 0.660, and the PNFL’s 0.547 was second highest39. The poor performance of most methods with network 2 is attributed to low effector gene levels in the wild type measurement22. In contrast, BINGO’s performance is less satisfactory with network 3, where the PNFL achieves almost perfect reconstruction. This might be due to a fairly high in-degree (four) of two nodes in the true network. Only one out of eight of these links gets higher confidence value than 0.5 assigned by BINGO. Based on Supplementary Table 4 and (ref. 1, Table 1), the impact of knockout data is largest in network 3. PNFL perhaps makes better use of these data. Also the BINGO*MCZ combination scores fairly well with network 3, but in network 2 it loses clearly to BINGO applied to all data directly.
As in the 10-gene case, BINGO outperforms its competitors by a clear margin in all five networks when inferring the 100-gene networks from time series data alone, and in fact, it scores slightly higher than the DREAM4 challenge winner. iCheMA is excluded due to its poor scalability to high dimension. When using all data, the combination BINGO*MCZ is the best performer, tied with the combination dynGENIE3*MCZ. It seems that with the 100-gene network, BINGO cannot always combine different types of data in an optimal way. This may be due to the large number of steady-state points where the dynamics function f should vanish. This hypothesis is supported by the deterioration of results when also the knockdown data is included with the knockout and time series data. It should be noted that both the DREAM4 winner as well as the MCZ use only the knockout and knockdown data, but they require knockout of every gene, which is hardly realistic in a real experiment.
Circadian clock of Arabidopsis thaliana: Realistic data were simulated from the so-called Millar 10 model of the Arabidopsis thaliana circadian clock25, using the Gillespie method42 to account for the intrinsic molecular noise. This model has been widely used to study the plant circadian clock and as a benchmark to assess the accuracy of different network inference strategies15. It simulates gene expression and protein concentration time series with rhythms of about 24 h. The gene regulatory structure consists in a three-loop feedback system of seven genes and their corresponding proteins whose chemical interactions are described using Michaelis–Menten dynamics. The model has been simulated for 600 h in 24-h light/dark cycles to remove transients. Then, the photoperiodic regime was switched to constant light. Ten replicates were simulated and the first 48 h of the constant light phase was recorded and downsampled to correspond to sampling intervals of 1, 2, or 4 h. The time series therefore consist of 49, 25, or 13 time points depending on the sampling interval. Two datasets were simulated with different levels of process noise, which is due to the random nature of gene expression. Process noise propagates through the network and therefore it should be beneficial to network inference algorithms.
Figure 2b–c shows the mean AUROC/AUPR values for the methods computed from the ten replicates (see also Supplementary Table 5). BINGO and dynGENIE3 are hardly affected by the decreasing sampling frequency. With less process noise, the AUROC values for these two methods are very close to each other in all cases, but BINGO has somewhat better precision throughout the tested sampling frequencies. With higher process noise, the results of BINGO improve clearly with all sampling rates. For dynGENIE3, iCheMA, and ARNI the performance improves slightly with higher process noise, at least with 1 and 2-h sampling rates. Most methods seem to be able to take advantage of the additional excitation due to process noise. The iCheMA and ARNI results with 4-h sampling rates and 2-h sampling rates with low process noise are not much better than random guessing.
In vivo dataset IRMA: A synthetic network26 was constructed with the purpose of creating an in vivo dataset with known ground truth network for benchmarking network inference and modelling approaches. The network is rather small, consisting of only five genes and eight links in the ground truth network (see Supplementary Fig. 1). Nevertheless, this dataset can be used to verify the performance of BINGO using real data.
The IRMA network can be “switched on” and “off” by keeping the cells in galactose or glucose, respectively. The dataset consists of nine transient time series obtained by qPCR technique, where the network is either switched on (five time series) or off (four time series) at the beginning of the experiment. These have been averaged into one switch-on time series (with 16 time points with 20-min sampling interval) and one switch-off time series (with 20 time points with 10-min sampling interval). Typically only the two average time series have been used, but here BINGO is applied both on the two average time series, and on all nine time series.
The resulting AUROC/AUPR scores are presented in Fig. 2d (and Supplementary Table 6). The dataset has been used also in other recent articles presenting methods ELM-GRNNminer5, and TimeDelay-ARACNE43. They only report one network structure as opposed to a list of links with confidence scores. Therefore it is not possible to calculate AUROC/AUPR scores for these methods, but their predictions can be presented as points with the ROC and precision-recall curves obtained for BINGO and dynGENIE3, shown in Fig. 3a, b. With such a small network, the AUROC and AUPR values are very sensitive to small differences in predictions. The best predicted network by BINGO using the averaged data has five out of eight links correct, and one false positive. The best predictions from dynGENIE3 with the same data have either four correct links with one false positive or five correct links with three false positives. However, it is not evident if these best predictions can be concluded from the results. With BINGO it is possible to look at the histogram of the posterior probabilities of all possible links, shown in Fig. 3c, d. In the averaged data case, the best prediction with five true links with one false positive stands out relatively well. Using the full data, there are three false positives that get confidence of over 0.9.
Fig. 3. Results for in vivo dataset IRMA.
The ROC (a) and precision-recall (b) curves for BINGO and dynGENIE3 using either all nine time series, or the two averaged time series together with predictions from the ELM-GRNNminer (obtained from ref. 5, Fig. 4) and the TD-ARACNE (from ref. 43, Fig. 5). c–d The histograms of posterior probabilities of all links for the averaged (c) and full (d) IRMA data. In the average data case, the prediction with three true positives and no false positives is obtained with threshold between 0.86 and 0.97. The best prediction with five true and one false positive is obtained with threshold between 0.25 and 0.45. In the full data case, the likely predictions are six true and four false positives with threshold between 0.66 and 0.85, or eight true positives (all) and five false positives with threshold 0.39 and 0.60.
Drug target identification
To demonstrate BINGO’s use in drug target identification, we apply it to a microarray dataset of the circadian clock of Arabidopsis thaliana44. The data consist of two experiments (each with two replicates): wild type (untreated) and nicotinamide (NAM) treated plants. The study is divided in two parts: a study of 17 known core circadian genes, and a larger study of 994 genes that were periodic in both datasets44. For each study, BINGO used all available data at once. To identify direct NAM targets, an external input was added with constant value zero for untreated plants and one for treated plants. Links from NAM to potential targets are modelled exactly as other links in the network. Figure 4a, b shows posterior probabilities for all links between the 17 clock genes. A threshold of 0.85 results in 11 links. A total of eight of those links are included in F14, a well known circadian clock model45 (note that F14 only has 10 of the 17 clock genes considered here). With a threshold of 0.5 (suggested by the gap in the histogram in Fig. 4b), 11 of the 18 modelled links are also in F14. Figure 4c shows posterior probabilities for NAM targets where seven links have clearly positive posterior probabilities. Of those, PRR9 and CRY2 were previously identified as NAM-targets44.
Fig. 4. Results for drug target identification.
a, b Histogram of posterior probabilities of all links for the 17-gene NAM data. c Histogram of posterior probabilities for NAM targets for the 17-gene data. d Histograms of posterior probabilities of all links for the 994-gene dataset. e Histogram of posterior probabilities for NAM targets in the 994-gene dataset. f Largest connected component of the network obtained with threshold 0.15 contains 963 genes.
To illustrate that BINGO can model large scale networks, we applied it to 994 periodic genes in both untreated and NAM plants. The posterior link probabilities are shown in Fig. 4d, and the resulting network is shown in Fig. 4f. This network is likely to reveal new gene interactions, requiring further experimental validations. Figure 4e shows the posterior probabilities histogram for NAM targets. Of those, CAP1 is a strong candidate that will be experimentally validated in future work.
Discussion
A nonparametric method BINGO was proposed for GRN inference, which is based on the continuous-time GPDM. The Gaussian process framework has proven very useful in nonlinear regression problems arising in machine learning. Due to the analytical tractability of Gaussian processes, it is possible to obtain a probability distribution for the trajectories of the GPDM. This allows MCMC sampling of the continuous trajectories, thereby bypassing a caveat of estimating derivatives from time series with low sampling frequency—a far too common procedure in existing GRN inference methods.
BINGO was favourably compared to state-of-the-art methods in GRN inference from time series data in various examples. In particular, it was demonstrated that the approach, based on sampling continuous gene expression trajectories, is good for handling time series data with low sampling frequency. Moreover, it was shown that the method can integrate steady-state data with time series data to improve performance. BINGO was also successfully applied on real biological data.
BINGO is computationally heavier than dynGENIE3, for example, which is among the best methods in terms of scalability to large dimensions. However, given the time, effort, and cost of a gene expression experiment, the computation time is hardly as important as the accuracy of predictions, as long as the method is scalable to high enough system dimension. MCMC approach is perfectly parallelisable: independent chains are run on different processors, and the collected samples are pooled together in the end. Parallelisation allows inference of networks of even a couple of thousands of variables. In the NAM target identification, BINGO was applied on a dataset with four time series of 994 genes, in which case the computation time was just under 19 h on a desktop workstation using 20 processors, which could be reduced by resorting to high performance computing.
Recently developed so-called single-cell techniques enable gene expression measurements in one cell resolution for a large number of cells at a time. The cell is destroyed in the measurement process, and therefore the data consist of ensemble snapshots rather than time series. It is possible to obtain so-called pseudotime series from such data46,47, and BINGO can be used on such time series—although a small modification in fitting the trajectory samples to the measurements is required, due to the large amount of measurements typically obtained from single-cell measurements. The method can also be integrated with a pseudotime estimator, but this is left for future development.
Other interesting future research topics include applying BINGO to solve different biological and biomedical real-data problems. Some theory on GPDMs is presented in Supplementary Notes 1–3. From a theoretical perspective, it would be desirable to relax smoothness requirements and to consider process noise with memory and/or dependence on the system’s state, which is also more realistic from the application point of view42.
Methods
Theory on continuous-time GPDMs
The existence and uniqueness of the solutions of the stochastic differential Eq. (2) are proven in Supplementary Note 1. The method’s practical implementation is based on discretising Eq. (2) on a partition π = {0 = τ0 < τ1 < … < τM = T} of the interval of interest [0, T] using the (continuous) Euler scheme
| 8 | 
for t ∈ [τk−1, τk] where k = 1, …, M. In Supplementary Note 2, it is shown that converges to the solution of Eq. (2), as the time discretisation is refined.
Probability distribution of the trajectory
The probability distribution p(X∣θ) is derived in this section for the discrete trajectory , where θ denotes collectively all the hyperparameters. The discrete trajectory is sampled from the continuous version given in Eq. (8), such that . That is, it satisfies
| 9 | 
where δτk ≔ τk − τk−1, and k = 1, …, M. It holds that
| 10 | 
For given f, the trajectory X is a Markov process, and therefore its distribution satisfies
| 11 | 
where
| 12 | 
The integral in Eq. (10) can be computed analytically (more details can be found in Supplementary Note 3). After some more manipulation, the probability distribution for the discretised trajectory is obtained:
| 13 | 
where Δτ is a diagonal matrix whose element (k, k) is δτk, , and . Same notation is also used for the different dimensions of the trajectory.
Note that p(X∣θ) corresponds to the finite-dimensional distribution of the continuous Euler-discretised trajectory satisfying Eq. (8), evaluated at discretisation points. In Supplementary Note 2, it is shown that converges strongly to the solution x of Eq. (2), and therefore the finite dimensional distributions converge as well. This means that p(X∣θ) is a proper finite dimensional approximation of the distribution of x.
Network inference method
Consider then the original problem, that is, estimating the hyperparameters from given time series data. Denote Y = [y0, y1, …, ym] where yj is assumed to be a noisy sample from the continuous trajectory x, that is, yj = x(tj) + vj, and where R = diag(r1, …, rn). The intention is to draw samples from the parameter posterior distribution using an MCMC scheme. Therefore, the posterior distribution is needed only up to constant multiplication. Denoting the hyperparameters collectively by θ, the hyperparameter posterior distribution satisfies p(θ∣Y) ∝ p(Y, θ) = ∫ p(Y, x, θ)dx = ∫ p(Y∣x, θ)p(x∣θ)p(θ)dx. Here p(Y∣x, θ) is the Gaussian measurement error distribution, p(x∣θ) will be approximated by p(X∣θ) given in Eq. (13) for the discretised trajectory X, and p(θ) is a prior for the hyperparameters. This prior consists of independent priors for each parameter. The integration with respect to the trajectory x is done by MCMC sampling. The function fi has mean mi(x) = bi − aixi where ai and bi are regarded as hyperparameters corresponding to basal transcription (bi ≥ 0) and mRNA degradation (ai ≥ 0), and the squared exponential covariance
| 14 | 
The covariance hyperparameters satisfy γi > 0 and βi,j ≥ 0. The network inference is based on estimating the parameters βi,j. If βi,j > 0, the function fi can depend on xj. In the context of GRN inference, it indicates that gene j is a regulator of gene i.
For the MCMC sampling of the hyperparameters βi,j, indicator variables are used48. That is, each of them is represented as a product βi,j = Si,jHi,j, where Si,j ∈ {0, 1} and Hi,j ≥ 0. The state of the sampler consists of the indicator variable S, the hyperparameters Hi,j, γi, ri, qi, ai, bi (i, j = 1, …, n) and the discrete trajectory X. The trajectory is sampled using a Crank–Nicolson sampler49,50 (see Supplementary Note 7). One row of the indicator matrix S is sampled by randomly choosing one element, and changing it from zero to one, or from one to zero. The other variables are sampled using a Metropolis–Hastings within Gibbs sampler with random walk proposals. A pseudo-input scheme51,52 is used to speed up the Gaussian process framework (see Supplementary Note 6).
The full algorithm is presented in Supplementary Note 4 (and Supplementary Table 1). In the drawn samples, the network structure information is in the indicator variable samples S(l), where l refers to the number of the sample. The output of the algorithm is the average of these samples, which converges as more and more samples are collected:
| 15 | 
Since S is zero-one valued, the element (i, j) of the matrix is the posterior probability that βi,j is not zero, given the data Y.
For qi, ri, and γi we use noninformative inverse Gamma priors. For Hi,j, ai, and bi we use Laplace priors (exponential), and for S we use where ∣S∣0 gives the number of ones in S. This prior means that the existence of a link is a priori independent of the existence of other links, and each link exists with probability . The parameter η ≥ 0 can be set to obtain a desired sparsity level for the samples. It is the only user-defined parameter in the method—save for discretisation steps and sampler step lengths. Prior distribution specifications are discussed in more detail in Supplementary Note 8. Other simulation details and computation times for the benchmark cases are presented in Supplementary Tables 2 and 3.
Several time series experiments, including knockout/knockdown experiments, can be easily incorporated by concatenating the time series. Steady state measurements are included by adding them into the dataset as points where f(xss) = 0. These procedures are described in Supplementary Note 5. It should be noted, however, that the concatenated time series should have similar properties. If this is not the case, for example if the different time series are obtained by different experimental techniques, or the pre-processing is different, then it is advised to use the method separately for each dataset. External inputs, such as the perturbations (with unknown targets) in the DREAM4 data can be included as additional state variables, which are not sampled. This feature is included in the method’s numerical implementation. If certain genes are interesting as potential regulators, but not as target genes, they can be included as inputs to reduce the computational burden of the method.
Data processing
The method can handle data from any experimental technique producing bulk time series data. It is assumed in the method that the time series data have been pre-processed appropriately, depending on the used experimental technique53–55. In particular, measurements between time points should be comparable, meaning that normalisation with respect to housekeeping genes should be carried out. By default, the BINGO code normalises the data by scaling the dynamical range of each gene () to one. In order to avoid noise amplification, it is important to exclude all genes from the data that are not properly expressed. Also genes that seem to be mostly noise, should be removed.
Pre-processing steps often include background removal and nonlinear transformations (e.g., taking logarithms). Moreover, microarray data are based on luminescence measurements which has a nonlinear dependency on the mRNA concentration. Constant shifts of the data have very little effect on BINGO, since the probability distribution in Eq. (13) only depends on differences of gene expression values between different time points. The only small effect of shifting data comes from the GP mean mi(x) = bi − aixi where a constant shift has an effect on the priors for ai and bi. Nonlinear transformation has a more intricate effect. Say zi = g(xi) with some smooth, invertible function g. If dxi = fi(x)dt + dwi, then
| 16 | 
The GRN topology is not affected by the nonlinear transformation, but the functional form, and the process noise characteristics are affected. The GP framework is flexible, and it should be able to fit to both fi(x) and .
As a general rule, BINGO should work best when the data correspond as closely as possible to the actual expression levels (that is, mRNA concentrations). However, if the data are very spiky, that is, concentrations peak very high on few measurement times, then a log-transformation might be beneficial, since BINGO assumes smooth dynamics functions.
Reporting summary
Further information on research design is available in the Nature Research Reporting Summary linked to this article.
Supplementary information
Acknowledgements
A.A. was supported in part by ERASysApp and Fonds National de la Recherche (FNR) Luxembourg reference INTER/SYSAPP/14/02, by University of Luxembourg Internal Research Project reference OptBioSys, and by FNR Luxembourg CORE Junior reference C19/BM/13684479. J.G. was partly supported by the 111 Project on Computational Intelligence and Intelligent Control under Grant B18024.
Author contributions
A.A. has developed the method and done the numerical implementation. The theory of the GPDM was developed by L.V. and he wrote Supplementary Notes 1 and 2. Major part of the main manuscript was written by A.A., with participation of P.I., L.M., and J.G. L.M. did part of the comparison studies, processed the real A. thaliana data, and wrote code for some data management and simulation of the Millar10 model.
Data availability
The four different datasets used in the article are available as follows:
• DREAM4 in silico network inference challenge data2,23,24,39 are available at https://www.synapse.org/#!Synapse:syn3049712/wiki/74630.
• Simulated data from Arabidopsis thaliana circadian clock are available as example data along with the method’s code.
• In vivo dataset IRMA26 are available as supplemental data for the article, 10.1016/j.cell.2009.01.055.
• Data from Arabidopsis thaliana circadian clock44 are available at: http://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE19271.
Code availability
The method’s MATLAB implementation is available at https://github.com/AtteAalto/BINGO.
Competing interests
The authors declare no competing interests.
Footnotes
Peer review information Nature Communications thanks Luonan Chen and the other, anonymous, reviewer(s) for their contribution to the peer review of this work. Peer reviewer reports are available.
Publisher’s note Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.
Supplementary information
Supplementary information is available for this paper at 10.1038/s41467-020-17217-1.
References
- 1.Penfold CA, Wild DL. How to infer gene networks from expression profiles. Interface Focus. 2011;1:857–870. doi: 10.1098/rsfs.2011.0053. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 2.Marbach D, et al. Revealing strengths and weaknesses of methods for gene network inference. Proc. Natl Acad. Sci. USA. 2010;107:6286–6291. doi: 10.1073/pnas.0913357107. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3.Huynh-Thu VA, Geurts P. dynGENIE3: dynamical GENIE3 for the inference of gene networks from time series expression data. Sci. Rep. 2018;8:3384. doi: 10.1038/s41598-018-21715-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.Casadiego J, Nitzan M, Hallerberg S, Timme M. Model-free inference of direct network interactions from nonlinear collective dynamics. Nat. Commun. 2017;8:2192. doi: 10.1038/s41467-017-02288-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 5.Rubiolo M, Milone D, Stegmayer G. Extreme learning machines for reverse engineering of gene regulatory networks from expression time series. Bioinformatics. 2017;34:1253–1260. doi: 10.1093/bioinformatics/btx730. [DOI] [PubMed] [Google Scholar]
- 6.Hill S, et al. Inferring causal molecular networks: empirical assessment through a community-based effort. Nat. Methods. 2016;13:310–318. doi: 10.1038/nmeth.3773. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7.Mohan K, London P, Fazel M, Witten D, Lee S-I. Node-based learning of multiple Gaussian graphical models. J. Mach. Learn. Res. 2014;15:445–488. [PMC free article] [PubMed] [Google Scholar]
- 8.Liu F, Zhang S-W, Guo W-F, Wei Z-G, Chen L. Inference of gene regulatory network based on local Bayesian networks. PLoS Comput. Biol. 2016;12:e1005024. doi: 10.1371/journal.pcbi.1005024. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Castro JC, 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 Phytophtora infestans. Theor. Biol. Med. Model. 2019;16:7. doi: 10.1186/s12976-019-0103-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Chan TE, Stumpf MPH, Babtie AC. Gene regulatory network inference from single-cell data using multivariate information measures. Cell Syst. 2017;5:251–267. doi: 10.1016/j.cels.2017.08.014. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Äijö T, Lähdesmäki H. Learning gene regulatory networks from gene expression measurements using non-parametric molecular kinetics. Bioinformatics. 2009;25:2937–2944. doi: 10.1093/bioinformatics/btp511. [DOI] [PubMed] [Google Scholar]
- 12.Oates CJ, et al. Causal network inference using biochemical kinetics. Bioinformatics. 2014;30:i468–i474. doi: 10.1093/bioinformatics/btu452. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13.Bansal M, DellaGatta G, diBernardo D. Inference of gene regulatory networks and compound modeof action from time course gene expression profiles. Bioinformatics. 2006;22:815–822. doi: 10.1093/bioinformatics/btl003. [DOI] [PubMed] [Google Scholar]
- 14.Klemm, S.Causal Structure Identification in Nonlinear Dynamical Systems. M.Phil. thesis, (University of Cambridge, UK, 2008).
- 15.Aderhold A, Husmeier D, Grzegorczyk M. Approximate Bayesian inference in semi-mechanistic models. Stat. Comput. 2017;27:1003–1040. doi: 10.1007/s11222-016-9668-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Mangan NM, Brunton S, Proctor J, Kutz JN. Inferring biological networks by sparse identification of nonlinear dynamics. IEEE Trans. Mol., Biol. Multi-Scale Commun. 2016;2:52–63. [Google Scholar]
- 17.Chartrand R. Numerical differentiation of noisy, nonsmooth data. ISRN Appl. Math. 2011;2011:164564. [Google Scholar]
- 18.Brunton S, Proctor J, Kutz JN. Discovering governing equations from data: Sparse identification of nonlinear dynamical systems. Proc. Natl Acad. Sci. USA. 2016;113:3932–3937. doi: 10.1073/pnas.1517384113. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19.Pan W, Yuan Y, Gonçalves J, Stan G-B. A sparse Bayesian approach to the identification of nonlinear state-space systems. IEEE Trans. Autom. Control. 2016;61:182–187. [Google Scholar]
- 20.Penfold CA, Shifaz A, Brown PE, Nicholson A, Wild DL. CSI: a nonparametric Bayesian approach to network inference from multiple perturbed time series gene expression data. Stat. Appl. Genet. Mol. 2015;14:307–310. doi: 10.1515/sagmb-2014-0082. [DOI] [PubMed] [Google Scholar]
- 21.Kojima K, et al. A state space representation of VAR models with sparse learning for dynamic gene networks. Genome Inf. 2010;22:56–68. [PubMed] [Google Scholar]
- 22.Küffner R, Petri T, Windhager L, Zimmer R. Petri nets with fuzzy logic (PNFL): reverse engineering and parametrization. PLoS ONE. 2010;5:e12807. doi: 10.1371/journal.pone.0012807. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.Marbach D, Schaffter T, Mattiussi C, Floreano D. Generating realistic in silico gene networks for performance assessment of reverse engineering methods. J. Comput. Biol. 2009;16:229–239. doi: 10.1089/cmb.2008.09TT. [DOI] [PubMed] [Google Scholar]
- 24.Prill RJ, et al. Towards a rigorous assessment of systems biology models: the DREAM3 challenges. PLoS ONE. 2010;5:e9202. doi: 10.1371/journal.pone.0009202. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 25.Pokhilko A, et al. Data assimilation constrains new connections and components in a complex, eukaryotic circadian clock model. Mol. Syst. Biol. 2010;6:416. doi: 10.1038/msb.2010.69. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 26.Cantone I, et al. A yeast synthetic network for in vivo assessment of reverse-engineering and modeling approaches. Cell. 2009;137:172–181. doi: 10.1016/j.cell.2009.01.055. [DOI] [PubMed] [Google Scholar]
- 27.Rasmussen C, Williams C. Gaussian Processes for Machine Learning. Cambridge, MA: MIT Press; 2006. [Google Scholar]
- 28.Wang JM, Fleet DJ, Hertzmann A. Gaussian process dynamical models for human motion. IEEE Trans. Pattern Anal. Mach. Intell. 2008;30:283–298. doi: 10.1109/TPAMI.2007.1167. [DOI] [PubMed] [Google Scholar]
- 29.Frigola, R., Lindsten, F., Schön, T. B. & Rasmussen, C. E. Bayesian inference and learning in Gaussian process state-space models with particle MCMC. Proc. Adv. Neural Inf. Process. Syst. 26, 3156–3164 (2013).
- 30.Eleftheriadis, S., Nicholson, T. F. W., Deisenroth, M. P. & Hensman, J. Identification of Gaussian process state space models. Proc. Adv. Neural Inf. Process. Syst. 5309–5319 (2017).
- 31.Lawrence N. Probabilistic non-linear principal component analysis with Gaussian process latent variable models. J. Mach. Learn. Res. 2005;6:1783–1816. [Google Scholar]
- 32.Chen, J., Kim, M., Wang, Y. & Ji, Q. Switching Gaussian process dynamic models for simultaneous composite motion tracking and recognition. Proc. IEEE Comput. Soc. Conf. Comput. Vis. Pattern Recognit., 2655–2662 (2009).
- 33.Gamage N, Kuang YC, Akmeliawati R, Demidenko S. Gaussian process dynamical models for hand gesture interpretation in sign language. Pattern Recognit. Lett. 2011;32:2009–2014. [Google Scholar]
- 34.Henter, G. E., Frean, M. R. & Kleijn, W. B. Gaussian process dynamical models for nonparametric speech representation and synthesis. Proc. IEEE International Conference on Acoustics, Speech and Signal Processing (ICASSP), 4505–4508 (2012).
- 35.Zhao J, Sun S. High-order Gaussian process dynamical models for traffic flow prediction. IEEE T. Intell. Transp. 2016;17:2014–2019. [Google Scholar]
- 36.Hachino T, Takata H, Fukushima S, Igarashi Y. Short-term electric load forecasting using multiple Gaussian process models. Int. J. Electr., Computer, Energetic, Electron. Commun. Eng. 2014;8:447–452. [Google Scholar]
- 37.MacKay DJC. Bayesian non-linear modelling for the prediction competition. ASHRAE Trans. 1994;100:1053–1062. [Google Scholar]
- 38.Neal, R. M.Bayesian Learning for Neural Networks. Lecture Notes in Statistics 118 (Springer, New York, 1996).
- 39.Sage Bionetworks. DREAM4 - in silico network challenge. https://www.synapse.org/#!Synapse:syn3049712/wiki/ (2015).
- 40.Pinna A, Soranzo N, de la Fuente A. From knockouts to networks: establishing direct cause-effect relationships through graph analysis. PLoS ONE. 2010;5:e12912. doi: 10.1371/journal.pone.0012912. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 41.Greenfield A, Madar A, Ostrer H, Bonneau R. DREAM4: Combining genetic and dynamic information to identify biological networks and dynamical models. PLoS ONE. 2010;5:e13397. doi: 10.1371/journal.pone.0013397. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 42.Gillespie D. The chemical Langevin equation. J. Chem. Phys. 2000;113:297–306. [Google Scholar]
- 43.Zoppoli P, Morganella S, Ceccarelli M. TimeDelay-ARACNE: Reverse engineering of gene networks from time-course data by an information theoretic approach. BMC Bioinforma. 2010;11:154. doi: 10.1186/1471-2105-11-154. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 44.Mombaerts L, et al. Dynamical differential expression (DyDE) reveals the periodic control mechanisms of the Arabidopsis circadian oscillator. PLoS Comput. Biol. 2019;15:e1006674. doi: 10.1371/journal.pcbi.1006674. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 45.Fogelmark K, Troein C. Rethinking transcriptional activation in the Arabidopsis circadian clock. PLoS Comput. Biol. 2014;10:e1003705. doi: 10.1371/journal.pcbi.1003705. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 46.Trapnell C, et al. The dynamics and regulators of cell fate decisions are revealed by pseudotemporal ordering of single cells. Nat. Biotechnol. 2014;32:381–391. doi: 10.1038/nbt.2859. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 47.Reid J, Wernisch L. Pseudotime estimation: deconfounding single cell time series. Bioinformatics. 2016;32:2973–2980. doi: 10.1093/bioinformatics/btw372. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 48.Aalto, A. & Gonçalves, J. Bayesian variable selection in linear dynamical systems. Preprint at http://arxiv.org/abs/1802.05753 (2018).
- 49.Beskos A, Roberts G, Stuart A, Voss J. MCMC methods for diffusion bridges. Stoch. Dyn. 2008;8:319–350. [Google Scholar]
- 50.Cotter SL, Roberts GO, Stuart AM, White D. MCMC methods for functions: modifying old algorithms to make them faster. Stat. Sci. 2013;28:424–446. [Google Scholar]
- 51.Snelson, E. & Ghahramani, Z. Sparse Gaussian processes using pseudo-inputs. Adv. Neural Inf. Process. Syst., 1257–1264 (2006).
- 52.Seeger, M., Williams, C. & Lawrence, N. Fast forward selection to speed up sparse Gaussian process regression. Artificial Intelligence Statistics9 (2003).
- 53.Everaert C, et al. Benchmarking of RNA-sequencing analysis workflows using whole-transcriptome RT-qPCR expression data. Sci. Rep. 2017;7:1559. doi: 10.1038/s41598-017-01617-3. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 54.Gyorffy B, Molnar B, Lage H, Szallasi Z, Eklund AC. Evaluation of microarray preprocessing algorithms based on concordance with RT-PCR in clinical samples. PLoS ONE. 2009;4:e5645. doi: 10.1371/journal.pone.0005645. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 55.Zhao S, Fung-Leung W-P, Bittner A, Liu X. Comparison of RNA-seq and microarray in transcriptome profiling of activated T cells. PLoS ONE. 2014;9:e78644. doi: 10.1371/journal.pone.0078644. [DOI] [PMC free article] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
The four different datasets used in the article are available as follows:
• DREAM4 in silico network inference challenge data2,23,24,39 are available at https://www.synapse.org/#!Synapse:syn3049712/wiki/74630.
• Simulated data from Arabidopsis thaliana circadian clock are available as example data along with the method’s code.
• In vivo dataset IRMA26 are available as supplemental data for the article, 10.1016/j.cell.2009.01.055.
• Data from Arabidopsis thaliana circadian clock44 are available at: http://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE19271.
The method’s MATLAB implementation is available at https://github.com/AtteAalto/BINGO.




