Skip to main content
  • Methodology article
  • Open access
  • Published:

Joint estimation of causal effects from observational and intervention gene expression data

Abstract

Background

In recent years, there has been great interest in using transcriptomic data to infer gene regulatory networks. For the time being, methodological development in this area has primarily made use of graphical Gaussian models for observational wild-type data, resulting in undirected graphs that are not able to accurately highlight causal relationships among genes. In the present work, we seek to improve the estimation of causal effects among genes by jointly modeling observational transcriptomic data with arbitrarily complex intervention data obtained by performing partial, single, or multiple gene knock-outs or knock-downs.

Results

Using the framework of causal Gaussian Bayesian networks, we propose a Markov chain Monte Carlo algorithm with a Mallows proposal model and analytical likelihood maximization to sample from the posterior distribution of causal node orderings, and in turn, to estimate causal effects. The main advantage of the proposed algorithm over previously proposed methods is its flexibility to accommodate any kind of intervention design, including partial or multiple knock-out experiments. Using simulated data as well as data from the Dialogue for Reverse Engineering Assessments and Methods (DREAM) 2007 challenge, the proposed method was compared to two alternative approaches: one requiring a complete, single knock-out design, and one able to model only observational data.

Conclusions

The proposed algorithm was found to perform as well as, and in most cases better, than the alternative methods in terms of accuracy for the estimation of causal effects. In addition, multiple knock-outs proved to contribute valuable additional information compared to single knock-outs. Finally, the simulation study confirmed that it is not possible to estimate the causal ordering of genes from observational data alone. In all cases, we found that the inclusion of intervention experiments enabled more accurate estimation of causal regulatory relationships than the use of wild-type data alone.

Background

The inference of gene regulatory networks from transcriptomic data has been a wide research area in recent years. Several approaches have been proposed to infer networks from observational transcriptomic data (also referred to as wild-type or steady-state expression data), mainly based on the use of graphical Gaussian models [1]. These methods, however, rely on the estimation of partial correlations and result in undirected graphs that cannot highlight the causal relationships among genes. For this reason, a great deal of research has focused instead on the use of causal Bayesian networks for a wide variety of applications [2, 3].

As an example, [4] and [5] make use of causal Bayesian networks in the case of multinomial data, where the former applies a score-based method and the latter samples graph structures using a Markov chain Monte Carlo (MCMC) approach. Using Gaussian causal Bayesian networks (GBN), Maathuis et al.[6, 7] recently proposed a method called Intervention-calculus when the DAG is Absent (IDA) to predict bounds for causal effects from observational data alone. In the IDA, the PC-algorithm [2, 8, 9] is first applied to find the associated completed partially directed acyclic graph (CPDAG), corresponding to the graphs belonging to the appropriate equivalence class. Following this step, bounds for total causal effects of each gene on the others are estimated using intervention calculus [10] for each directed acyclic graph (DAG) in the equivalence class.

However, if intervention experiments such as gene knock-outs or knock-downs are available, it is valuable to jointly perform causal network inference from a combination of wild-type and intervention data. One such approach has been proposed by Pinna et al.[11], based on the simple idea of calculating the deviation between observed gene expression values and the expression under each systematic intervention. In particular, Pinna et al. propose the calculation of several matrices to evaluate the differences between observational and intervention expression values: a simple deviation matrix, a standardized deviation matrix, and a z-score deviation matrix. In addition, for large networks (e.g., 100 genes), a down-ranking algorithm is applied to the initial graph obtained from these deviation matrices to remove feed-forward edges. In order to evaluate all possible causal links among genes, the method requires a single replicate of observational data as well as a single knock-out experiment for each gene in the network. An improved version of the Pinna approach was very recently proposed [12] to provide more accurate network inference for large-scale networks through a novel implemention of the transitive reduction step. As with the originally proposed method, this approach also requires systematic single knock-outs for all genes in the network.

The method proposed in [11] has the dual advantages of being very fast to compute and being quite general, as it does not require any assumption of acyclicity of the graph. In addition, as this method provided the best network estimation in the Dialogue for Reverse Engineering Assessments and Methods (DREAM4) in silico 100-gene network sub-challenge [1316], it may be considered as a reference. We note that the method with the best performance for the DREAM4 10-gene network subchallenge was that of [17], based on an automated approach using Petri Nets with Fuzzy Logic; unfortunately, no software is publicly available to implement this method, making it difficult to use in practice.

In this work we propose a novel method in the context of GBNs using a Markov chain Monte Carlo (MCMC) algorithm and Mallows model that is flexible enough to accurately infer causal gene networks from an arbitrary mixture of observational and intervention data, including partial and multiple gene knock-out experiments. As such, the novelty of the proposed method is as follows: 1) it is the only method able to fully make use of all available intervention information, 2) it does not require a systematic intervention experiment to be performed for each gene, and 3) it can deal with sophisticated multiple intervention designs. To benchmark its performance on observational data alone as well as systematic single knock-out data, the proposed method was compared to those of [7] and [11] on simulated data as well as the data from the DREAM4 challenge [13]; in addition, we also consider more complicated simulations based on partial and multiple knock-out designs.

Methods

Gaussian Bayesian network framework

Let G = (V,E) be a graph defined by a set of vertices V and edges E(V×V). Let the vertices of a graph represent p random variables X1,…,X p . As in the approach of [7], we consider here the framework of causal GBNs, which correspond to Bayesian networks where the nodes have a Gaussian residual distribution and edges represent linear dependencies. In this case, it also follows that the joint distribution of the network is multivariate Gaussian.

In DAGs such as GBNs, we often encounter the presence of Markov equivalence classes, i.e. multiple network structures that yield the same joint distribution; in such cases, observational data alone generally cannot orient edges. For this reason, in many cases the use of intervention data can help overcome this issue, as presented below.

Calculation of causal effects

Following an intervention on a given node X i , denoted do(X i  = x), we consider the expected value of each other gene in the network via do-calculus as shown in Theorem 3.2.2 (Adjustment for direct causes) in [10]:

E ( X j | do ( X i = x ) ) = E ( X j ) if X j pa ( X i ) E ( X j | x , pa ( X i ) ) ( pa ( X i ) ) d pa ( X i ) if X j pa ( X i )

where pa(X i ) represents the parents of node X i . It is important to point out that (Y|do(X=x)) is different from the conditional probability (Y|X=x). Using this framework, the total causal effects may be defined as follows:

β ij = ∂x E ( X j | do ( X i = x ) )

and are equal to 0 if X i is not an ancestor of X j . On the other hand, the direct causal effects (i.e. the edges in the graph) are defined as:

α ij = ∂x E ( X j | pa ( X j ) , do ( X i = x ) ) .

Proposed causal inference method

In the GBN framework, when observational data are jointly modeled with intervention data for an arbitrary subset of genes, the network follows a multivariate Gaussian distribution of dimension equal to the number of genes that had no intervention (as the expression value of the gene under intervention is fixed to a given value), and the log-likelihood value can subsequently be calculated for a proposed network.

The calculations in the following section assume that the nodes in the graph have been sorted according to an appropriate causal ordering in the graph such that if i<j, then X j is not an ancestor of X i ; we note that such an ordering is possible under the assumption of acyclicity of the graph. In practice, of course, it is typically not possible to correctly order nodes in such a way without knowledge of the underlying DAG. For this reason, we aim to explore various network structures based on causal orderings, and to choose among those with the best likelihood value for an arbitrary set of observational and intervention data. The Metropolis-Hastings algorithm [18, 19], through the use of a proposal distribution for causal orderings, allows such an exploration to take place and to approach a local maximum of the likelihood.

Likelihood calculation

Let p be the number of nodes in the graph, G the DAG structure and W the matrix containing the values for all edges. The nodes are assumed to have been sorted by parental order for G and W, i.e. if i<j, then X j is not an ancestor of X i . This sorting is possible under the assumption of acyclicity and may not necessarily be unique. Under this ordering, W is an upper triangular matrix and thus nilpotent. In the GBN framework, it is assumed that each node of G has a residual Gaussian distribution, independently from the rest of the network. Let us consider X I with I={1,,p}, a set of p Gaussian random variables defined by:

X j = m j + i pa ( j ) w i , j X i + ε j with ε j N(0, σ j 2 ).
(1)

We assume that the ε j are independent, and that ipa(j)i<j (this assumption is equivalent to assuming that the directed graph obtained using the parental relationships is acyclic). Given the parental structure of the graph, wi,j may only be nonzero on the edge set, (i,j)E={ipa(j),jI}.

Let us now consider the matrix form of Equation (1):

X = m + X W + ε

where X = (X1,…,X p ), m = (m1,…,m p ), and ε = (ε1,…,ε p ) are row-vectors of dimension p, and W = (wi,j)1≤i,jp is a p-dimensional square matrix. By recursively applying this formula and taking advantage of the nilpotence of matrix W, we obtain:

X = m L + ε L

where L = (I-W)-1 = I + W + … + Wp-1. This proves that the model defined in Equation (1) is equivalent to XN(μ,Σ) with:

μ = m L and Σ = L T diag ( σ 2 ) L = j I σ j 2 L T e j T e j L

where e j is a p-dimensional null row-vector except for its jth term which is equal to 1, and where σ = (σ1,…,σ p ) is a row-vector of dimension p.

The log-likelihood of the model given N observations x k =( x 1 k ,, x p k ) (1≤kN) is then:

( m , σ , W ) = - Np 2 log ( 2 π ) - N j I log ( σ j ) - 1 2 k = 1 N j I 1 σ j 2 ( x j k - x k W e j T - m j ) 2 .

To see this, let us define A k  = (xk-m L)Σ-1(xk-m L)T for all k. Since Σ-1 = (I-W)diag(1/σ2)(I-W)T we get:

A k = j I 1 σ j 2 ( x k ( I - W ) - m ) e j T e j ( x k ( I - W ) - m ) T = j I 1 σ j 2 ( x j k - x k W e j T - m j ) 2 .

As shown in the Additional file 1, analytical formulae can be obtained for the derivatives with respect to parameters θ = (m,σ,W).

The likelihood presented above only takes into account observational data. Let us now consider the case of an arbitrary mixture of observational and intervention data. We assume that we perform an intervention on a subset JI={1,,p} of variables by artificially fixing the level of the corresponding variables to a value (typically 0 in the case of knock-out experiments): do( X J = x J ). The model is then obtained by assuming that all wi,j = 0 for (i,j)E and jJ; we denote the corresponding matrix W J . We also assume that the variables X j for jJ are fully deterministic. As before, the resulting model is hence Gaussian: X I |do( X J = x J )N( μ J ( x J ), Σ J ) with

μ J ( x J ) = ν J ( x J ) L J , Σ J = j J σ j 2 L J T e j T e j L J ,

where

ν J ( x J ) e j T = x j if j J m j otherwise and L J = ( I - W J ) - 1 = I + W J + + W J p - 1 .

For the likelihood calculation, we consider N data generated under x k =( x 1 k ,, x p k ) (1≤kN) with intervention on J k (where J k = means no intervention). We denote by K j ={k,j J k }, and by N j =| K j | its cardinal. The log-likelihood of the model can then be written as:

( m , σ , W ) = - log ( 2 π ) 2 j N j - j N j log ( σ j ) - 1 2 k j J k 1 σ j 2 ( x j k - x k W e j T - m j ) 2 .
(2)

This is mainly due to the fact that for any intervention set we have W J e j T =W e j T for all jJ. Considering the derivative with respect to m j for all j such that N j >0, we obtain:

m j = 1 N j k K j ( x j k - x k W e j T )

which can be plugged into the likelihood expression to get:

~ ( σ , W ) = - log ( 2 π ) 2 j N j - j N j log ( σ j ) - 1 2 k j J k 1 σ j 2 ( y j k , j - y k , j W e j T ) 2

where for (k,j) such that j J k we have:

y k , j = x k - 1 N j k K j x k

and W can be estimated by solving the following linear system:

i , ( i , j ) E w i , j k K j y i k , j y i k , j = k K j y i k , j y j k , j for all(i,j)E.
(3)

Note that the system might be degenerate if the intervention design gives no insight on some parameters. It is hence finally possible to obtain σ through:

σ j 2 = 1 N j k K j ( y j k , j - y k , j W e j T ) 2 .

Proposed MCMC algorithm

The Metropolis-Hastings algorithm [18, 19] is a random walk over Ω, the parameter space of the model. It relies on an instrumental probability distribution Q which defines the transition from position X t to a new position X. The probability of moving from state X t to the new state X is defined by:M

P ( X t + 1 = X | X t ) = min π ( X ) Q ( X t , X ) π ( X t ) Q ( X , X t ) , 1
(4)

where π(X) is the likelihood function.

In order to propose a new causal node ordering O from the previous ordering , we propose to make use of the Mallows model [20]. Briefly, under this model, the density of a proposed causal ordering is defined as follows:

P ( O ) = P ( O | O , ϕ ) = 1 Z ϕ d ( O , O )

where ϕ(0,1] is a fixed temperature parameter, Z is a normalizing constant, and d(·,·) is a dissimilarity measure between and O based on the number of pairwise ranking disagreements. In addition, we remark that as the temperature parameter ϕ approaches zero, the Mallows model approaches a uniform distribution over all causal orderings, and if ϕ=1, the model corresponds to a dirac distribution on the reference ordering . In the following, we will use a reparameterization of the temperature coefficient ϕ such that ϕ = exp(-1/η), with η>0. Due to the symmetry of d, it is clear that P( O |O,ϕ)=P(O| O ,ϕ), which allows a simplification of the Q terms in the acceptance ratio in Equation (4). We note that a related MCMC approach to explore the space of causal node orderings was recently proposed by [5] in the case of categorical data, making use of an equi-energy sampler.

Proposals for causal node orderings using the aforementioned Mallows model may be obtained by sampling using a repeated insertion model as described in [21]. Based on this new proposal for the node ordering O , maximum likelihood estimators may be calculated for the model parameters θ = (m,σ,W) using the likelihood described in Equation (2). Subsequently, the Metropolis-Hastings ratio may be calculated and used to determine whether the proposed causal node ordering is accepted or rejected.

R code to implement the proposed MCMC-Mallows algorithm, as well as a sample script providing an example to run the algorithm for a set of simulated data, may be found in Additional files 2 and 3.

Results and discussion

Simulation study

Data were simulated under a GBN as in Equation (1) with 10 genes and 21 edges and as described in [9]; the underlying structure is given in Figure 1. For the residual distributions of each gene, we chose 0.5 for the means and three settings for the standard deviations (σ=0.01, 0.1 and 0.5), which correspond to small, moderate and large noise for the marginal distributions. Non-zero parameters wi,j were simulated with values drawn uniformly from (-1,-0.25)(0.25,1), and for each setting, 100 datasets were generated. The goal was to try to accurately infer the total and direct causal effects among genes.

Figure 1
figure 1

Graph structure used in simulation study. Graph structure taken from [9] used for the simulation study for a graph with ten nodes and 21 edges.

Several intervention designs were simulated: 1) 20 observational (wild-type) replicates with no interventions, 2) a mixed setting with 10 wild-types and one knock-out per gene, 3) a partial knock-out design with 15 wild-types and one knock-out for five genes: {N1, N4, N6, N7, N9}, 4) a multiple knock-out design with 10 wild types, one knock-out per gene and five double knock-outs: {N1, N5}, {N1, N6}, {N4, N7}, {N6, N9}, and {N7, N10} and 5) a multiple knock-out design as in the previous setting, where all simulated data for three randomly chosen genes were removed (resulting in a set of three hidden variables). Note that we have previously shown [22] that observational data alone (Setting 1 described above) are not informative for the causal node ordering as in such a case, the likelihood is invariant to permutations of the order. Consequently, in this setting node orderings were uniformly sampled rather than using the MCMC-Mallows algorithm; we refer to this strategy as MCMC-uniform.

An MCMC algorithm with Mallows proposal distribution was run to explore the posterior distribution of causal node orderings, as presented in the previous section, with full estimation of θ = (m,σ,W) using the maximum likelihood estimators. For the simulations, a small trial run of 1000 iterations was run over a range of possible temperature values η (0.2 to 1.5 by 0.1) for the Mallows model, and the value yielding an acceptance rate closest to 30 to 40% [23] was subsequently used for the full run of the MCMC algorithm. In all simulation settings tested here, this value was chosen to be η = 0.6 (for σ = 0.01 and 0.1) or η = 1 (for σ = 0.5). As a comparison, we also attempted a trial run of the algorithm using a naive uniform proposal distribution (η = 1010) in place of the Mallows model, which generally led to acceptance rates of less than 1%. The MCMC-Mallows algorithm was subsequently run for 50,000 iterations, including a burn-in of 5000 iterations and thinning every 50 iterations. We note that due to the analytical maximization step of the likelihood, the method is quite fast and takes only a few minutes to run for each dataset.

In order to benchmark its performance on observational data alone as well as systematic single knock-out data, the proposed algorithm was compared to two previously proposed methods: 1) Pinna [11], which requires a single, systematic knock-out to be performed for every gene, and 2) IDA [7] using the PC-algorithm [2], which only makes use of the observational data. As the PC-algorithm used by [7] provides bounds (a,b) for the estimated causal effects, we considered two options to facilitate comparisons with the other methods: an “optimistic” calculation, where we use the value max(abs(a,b)), and a more conservative “pessimistic” strategy, using the value min(abs(a,b)) if a and b have the same sign, 0 otherwise.

Finally, several criteria were used to compare the different methods on both total causal effects and direct causal effects: area under the receiver operating characteristic (ROC) curve (AUROC), area under the precision-recall curve (AUPRC), Spearman correlation between true and estimated total or direct causal effects, and the mean squared error (MSE) of estimated total or direct causal effects. Note that the results are calculated for the full L = (I-W)-1 (total causal effects) and W matrices (direct causal effects) and not just the upper triangular. For the AUROC and AUPRC calculations, positive edges corresponded to (total or direct) causal effects with a nonzero value, and negatives corresponded to (total or direct) causal effects with a null value.

Results for total causal effects are presented in Table 1 for σ = 0.1, and in Tables S1 and S2 in Additional file 1 for σ=0.01 and 0.5. It can first be noted that results for the IDA method are identical for different levels of variation σ; this is due to the fact that it operates on sufficient statistics (correlation matrices) rather than on the data themselves. Similarly, results are identical for the MCMC-uniform method at different levels of σ when only observational data are present. Based on observational data only, we note that the proposed algorithm performs as well as the IDA approach; this is unsurprising as both methods are based on GBNs.

Table 1 Comparison of methods for total causal effects for simulated data with moderate variability ( σ=0.1 )

When single knock-outs were simulated (one for each gene) with a large variability (σ = 0.5), the IDA [7] approach has slightly more accurate estimation of causal effects than Pinna [11], although we recall that the former method solely makes use of the observational data. On the other hand, when the amount of variability decreases (σ = 0.1 and 0.01), the Pinna approach outperforms IDA, even for the optimistic version. In all three settings (σ = 0.5, 0.1, 0.01), the proposed MCMC-Mallows algorithm was better able to estimate the causal effects than either Pinna or IDA, as shown by the different criteria presented here. Similar conclusions may be obtained in the context of partial intervention designs. The MCMC-Mallows approach was found to outperform the IDA approach, especially for moderate and low variability. As it requires knock-outs to be performed for all genes in the network, the performance of the Pinna approach suffers when only a subset of interventions are available.

In addition, it was found that considering multiple knock-outs led to an improvement of the estimation of the causal effects over single knock-outs alone. We note that, like the partial knock-out design, this complex intervention design can only be fully accommodated by the proposed MCMC-Mallows method. In this setting, the Pinna method uses only information on the 10 single knock-outs and the IDA approach only the observational data. Finally, in the multiple knock-out setting where data for three genes were hidden, resulting in a set of latent variables, we note that the MCMC-Mallows approach appears to be least affected by the missing information and maintains a satisfactory performance. Similar conclusions may be drawn concerning the comparisons among methods for the direct total causal effects, shown in Table 2 and Tables S3 and S4 in Additional file 1.

Table 2 Comparison of methods for direct causal effects for simulated data with moderate variability ( σ = 0.1 )

Figure 2 presents the posterior distribution of causal node ordering from the MCMC-Mallows method averaged over 100 simulations for the observation data only (top left), the mixed setting with 10 wild types and one knock-out for each gene (top right), the partial knock-out setting (bottom left), and the multiple knock-out setting (bottom right) for moderately noisy data (σ = 0.1). Note that a plot is not included for the hidden variable design, as the true and estimated node orderings are dependent on which three genes are selected to be removed. In these plots, node labels are included on the vertical axis, and estimated positions within orderings along the horizontal axis. Potential orderings for each node within the true graph are highlighted with black outlines; as an example, node N6 could be placed in the first, second, or third position, while node N3 could only be placed in the tenth position in the true graph. The intensity of colors within each box represents the average proportion of iterations in which a node was placed in a particular order. To follow our example, in the mixed setting (top right of Figure 2), on average node N6 was most often placed in the first position, and occasionally positioned second or third, while node N3 was nearly always placed in the last position.

Figure 2
figure 2

Posterior distribution of node orders from the MCMC-Mallows approach, averaged over 100 simulations. Results from simulation setting with σ = 0.1: Observations only (top left), complete single knock-outs (top right), partial single knock-outs (bottom left), multiple knock-outs (bottom right). Node labels are included on the vertical axis, estimated positions within causal orderings along the horizontal axis, and the intensity of color of each square corresponds to the average proportion of iterations in which a given node was placed in a given position. As the causal node ordering is not unique for this DAG, true potential positions for each node are outlined in black.

We may remark on several points. First, as shown in the Methods section, it is not possible to estimate the node orders from observational data only. As expected, the node orders were more accurately estimated when a complete knock-out design was considered, with one knock-out for each gene, than for a partial knock-out design. For low to medium variability (σ=0.01 and 0.1) the proposed algorithm was able to very accurately estimate the potential node orders for the complete and multiple knock-out designs (see Figures S1–S4 in Additional file 1). Finally, we note that the node ordering is not unique for the DAG considered here, as illustrated by the black squares in Figure 2.

DREAM data analysis

The proposed MCMC-Mallows algorithm as well as the two previously presented methods [7, 11] were applied to data from the DREAM4 challenge, an international competition held yearly to contribute to the development of powerful inference methods [1316]. In the DREAM4 in silico network challenge, network topologies (with feedback loops) were extracted from transcriptional regulatory networks of E. coli and S. cerevisiae, and data were subsequently simulated and distributed to the participants. The goal was to infer directed regulatory networks from simulated data with either 10 or 100 genes. Based on the considered evaluation criteria (AUROC and AUPRC), the Petri Nets with Fuzzy Logic method [17] and Pinna method [11] were found to be the best performers for the 10-gene and 100-gene network challenges, respectively. In this paper we will focus on the five simulated 10-gene networks and perform inference based on wild type and multifactorial perturbation data (jointly considered to be observational data) as well as knock-out data.

Figure 3 presents the ROC curves as well as the precision-recall curves for the different methods in each of the five DREAM4 datasets. Table 3 contains the values for the AUROC and AUPRC for each method on each of the five DREAM4 datasets, as well as the overall DREAM score for each. The overall DREAM score is calculated as the average of global AUROC and AUPR scores, which are calculated across all datasets as the mean of the - log10p-values (calculated via permuation tests) for each dataset. As a point of reference, the reported performance of the top-performing method from the DREAM4 challenge, Petri Nets with Fuzzy Logic [17], is also provided; we could not confirm these results as no software is publicly available for its implementation.

Figure 3
figure 3

Comparison of methods on data with a complete design from the DREAM4 challenge. ROC curves (top) and precision-recall curves (bottom) for the five simulated 10-gene networks of the DREAM4 challenge [13] for the MCMC-Mallows, Pinna, and IDA (optimistic and pessimistic) methods.

Table 3 Comparison of methods on complete DREAM4 data

It can first be observed that the IDA [7], whether optimistic or pessimistic versions of the causal effects estimations are used, performs the worst; this is unsurprising, as it only makes use of the observational data. On the other hand, the proposed MCMC-Mallows method compares quite well to the Pinna approach, except for the first data set where Pinna clearly outperforms the others. We note that the simulated intervention setting was well adapted to the Pinna method, as one knock-out was available for each gene; in addition, we note that as the MCMC-Mallows and IDA methods are based on a causal Bayesian network framework, feedback loops in the network cannot be modeled due to the assumption of acyclicity in the graph. Finally, it can be seen that the Petri Nets method of [17] significantly outperforms the other methods on these data; however, we recall that the major contribution of our proposed MCMC-Mallows approach is not its ability to best model complete, single knock-out intervention designs but rather its unique flexibility to accommodate more complex or incomplete intervention designs, as we demonstrate in the following.

To assess the performance of each of the methods on the DREAM4 data with only an incomplete set of gene knock-out experiments (similar to the partial knock-out simulation above), we remove half of the knock-out experiments (chosen at random) from each dataset. Figure 4 presents the ROC and precision-recall curves for this partial knock-out setting and Table 4 provides the AUROC, AUPRC, and overall DREAM scores. As no software is publicly available to implement the Petri Nets approach, no results for this method may be obtained in this context. The performance of IDA is identical in this setting to that of the full data, as it uses the observational data alone. The loss of information as compared to the complete data is reflected in the lower overall DREAM scores for both the MCMC-Mallows and Pinna approaches; we note that in nearly all cases (with the exception of the second dataset), the Pinna method is adversely affected by the loss of intervention data as compared to the previous results. On the other hand, the MCMC-Mallows appears to be the least adversely affected by the incomplete design and maintains a similar performance to the complete design. As such, although the complete intervention design clearly yields more information about causal effects among genes, the MCMC-Mallows approach appears to be best able to extract pertinent information when only partial intervention designs are available.

Figure 4
figure 4

Comparison of methods on data with a partial design from the DREAM4 challenge. ROC curves (top) and precision-recall curves (bottom) for the five simulated 10-gene networks of the DREAM4 challenge [13], where for each dataset five knock-outs were removed at random, for the MCMC-Mallows, Pinna, and IDA (optimistic and pessimistic) methods.

Table 4 Comparison of methods on partial DREAM4 data

Conclusions

In this paper we proposed a flexible and powerful approach for joint causal network inference from both observational and intervention data, using an MCMC algorithm and Mallows model. The computational efficiency of the method is very much improved by the analytical maximization step of the likelihood.

In the simulation study presented above, the proposed MCMC-Mallows algorithm was found to perform better than Pinna [11] and IDA [7] in terms of accuracy of estimation of the causal effects, as evidenced by the tendancy to have larger AUROC, larger Spearman correlation coefficients and smaller MSE than the other approaches. Additionally, our simulations demonstrated that multiple knock-out designs contributed valuable additional information for causal network inference beyond single knock-outs; we therefore anticipate that the need for methods able to accommodate complex intervention designs will only increase as such data become more common. The results for the complete DREAM4 data are somewhat inconclusive, with Pinna performing best on two datasets, MCMC-Mallows best on two others, and nearly equivalent performance on the last; in addition, all methods considered here performed considerably worse than the winning Petri Nets method of [17] on the complete set of data. We note that the DREAM networks, like many real biological networks, contain feedback loops that cannot be modeled by methods based on causal Bayesian networks such as MCMC-Mallows and IDA. However, despite this limitation, the results of the partial design for DREAM4 data demonstrate that the MCMC-Mallows method is best able to accommodate complex intervention designs, including partial gene knock-outs. In fact, the novelty of the MCMC-Mallows approach, and the primary contribution of this work, lies in its flexibility to model arbitrary single, multiple, and partial knock-out designs.

In its present form, the proposed algorithm is not applicable to large-scale networks made up of several hundreds of nodes. Due to the curse of dimensionality, the size of the search space of causal node orderings explodes in dimension as the number of nodes increases, meaning that alternative MCMC samplers, such as parallel tempering, may be better suited to such situations. In addition, the resolution of the linear system in Equation (3) needed for the likelihood calculation has complexity O(p6) when no sparsity constraints are included for matrix W. As such, the generalization of the proposed algorithm to a p>>n situation will require the addition of a ridge or Lasso penalty, as recently proposed by [24], as well as a modification of the proposal distribution and sampling strategy. The current algorithm is fully compatible with such extensions and this will be the focus of our research in the near future.

The choice of optimal experimental knock-out designs is an important issue for causal inference and merits further attention. Hauser and Bühlmann [25] recently proposed two strategies for the choice of optimal interventions. The first is a greedy approach using single-vertex interventions that maximizes the number of edges that can be oriented after each intervention; the second yields a minimum set of targets of arbitrary size that guarantee full identifiability. However, alternative approaches could be envisaged in future research. In particular, recall that in the GBN framework, the likelihood associated to the multivariate Gaussian distribution of the network can be explicitly written as presented in this work. The choice of optimal knock-outs to be performed to improve and validate the causal inference can then rely on the evaluation of the amount of information contributed by each possible intervention, which can for example be obtained by the Fisher information. Its calculation requires the derivation of the likelihood function, which is not trivial but has already been derived in [22]. We anticipate that this issue will remain an interesting challenge for future research.

References

  1. Friedman J, Hastie T, Tibshirani R: Sparse inverse covariance estimation with the graphical lasso. Biostatistics. 2008, 9 (3): 432-441. 10.1093/biostatistics/kxm045.

    Article  PubMed  PubMed Central  Google Scholar 

  2. Spirtes P, Glymour C, Scheines R: Causation, Prediction, and Search. 2001, Cambridge, MA, USA: The MIT Press

    Google Scholar 

  3. Pearl J: The logic of counterfactuals in causal inference. J Am Stat Assoc. 2000, 95: 428-435.

    Google Scholar 

  4. Cooper G, Yoo C: Causal discovery from a mixture of expeirmental and observational data. Proceedings of the 15th Conference on Uncertainty in Artificial Intelligence. 1999, San Francisco, CA: Morgan Kaufmann

    Google Scholar 

  5. Ellis B, Wong W: Learning causal Bayesian network structures from experimental data. J Am Stat Assoc. 2008, 103 (482): 778-789. 10.1198/016214508000000193.

    Article  CAS  Google Scholar 

  6. Maathuis M, Colombo D, Kalisch M, Bühlmann P: Predicting causal effects in large-scale systems from observational data. Nat Methods. 2010, 7: 247-248. 10.1038/nmeth0410-247.

    Article  PubMed  CAS  Google Scholar 

  7. Maathuis M, Kalisch M, Bühlmann P: Estimating high-dimensional intervention effects from observational data. Ann Stat. 2009, 37: 3133-3164. 10.1214/09-AOS685.

    Article  Google Scholar 

  8. Kalisch M, Mächler M, Colombo D, Maathuis M, Bühlmann P: Causal inference using graphical models with the R package pcalg. J Stat Softw. 2012, 47 (11): 1-26.

    Article  Google Scholar 

  9. Kalisch M, Bühlmann P: Estimating high-dimensional directed acyclic graphs with the PC-algorithm. J Mach Learn Res. 2007, 8: 613-636.

    Google Scholar 

  10. Pearl J: Causality: Models, Reasoning and Inference. 2000, New York, NY, USA: Cambridge University Press

    Google Scholar 

  11. Pinna A, Soranzo N, de la Fuente A: From knockouts to networks: establishing direct cause-effect relationships through graph analysis. PLoS ONE. 2010, 10 (5): e12912-

    Article  Google Scholar 

  12. Pinna A, Heise S, Flassig R, Klamt S, de la Fuente A: Reconstruction of large-scale regulatory networks based on perturbation graphs and transitive reduction: improved methods and their evaluation. BMC Syst Biol. 2013, 7: 73-10.1186/1752-0509-7-73.

    Article  PubMed  PubMed Central  Google Scholar 

  13. Stolovitzky G, Monroe D, Califano A: Dialogue on reverse-engineering assessment and methods: The DREAM of high-throughput pathway inference. Ann N Y Acad Sci. 2007, 1115: 1-22. 10.1196/annals.1407.021.

    Article  PubMed  Google Scholar 

  14. Marbach D, Schaffter CTandMatiussi, Floreano D: Generating realistic in silico gene networks for performance assessment of reverse engineering methods. J Comput Biol. 2009, 16 (2): 229-239. 10.1089/cmb.2008.09TT.

    Article  PubMed  CAS  Google Scholar 

  15. Marbach D, Prill RJ, Schaffter T, MAttiussi C, Floreano D, Stolovitzky G: Revealing strengths and weaknesses of methods for gene network inferene. PNAS. 2010, 107 (14): 6286-6291. 10.1073/pnas.0913357107.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  16. Prill RJ, Marbach D, Saez-Rodriguez J, Sorger PK, Alexopoulos LG, Xue X, Clarke ND, Altan-Bonnet G, Stolovitzky G: Towards a rigourous assessment of systems biology models: the DREAM3 challenges. PLoS ONE. 2010, 5 (e9202):

  17. Küffner R, Petri T, Windhager L, Zimmer R: Petri nets with fuzzy logic (PNFL): reverse engineering and parametrization. PLoS ONE. 2010, 5 (9): e12807-10.1371/journal.pone.0012807.

    Article  PubMed  PubMed Central  Google Scholar 

  18. Metropolis N, Rosenbluth A, Rosenbluth M, Teller A, Teller E: Equations of state calculations by fast computing machines. J Chem Phys. 1953, 21 (6): 1087-1092. 10.1063/1.1699114.

    Article  CAS  Google Scholar 

  19. Hastings W: Monte Carlo sampling methods using Markov chains and their applications. Biometrika. 1970, 57: 97-109. 10.1093/biomet/57.1.97. [http://dx.doi.org/10.1093/biomet/57.1.97]

    Article  Google Scholar 

  20. Mallows C: Non-null ranking models. Biometrika. 1957, 44: 114-130.

    Article  Google Scholar 

  21. Doignon J, Pekec A, Regenwetter M: The repeated insertion model for rankings: Missing link between two subset choice models. Psychometrika. 2004, 69: 33-54. 10.1007/BF02295838.

    Article  Google Scholar 

  22. Nuel G, Rau A, Jaffrézic F: Joint likelihood calculation for intervention and observational data from a Gaussian Bayesian network. 2013,, arXiv:1305.0709v4,

    Google Scholar 

  23. Roberts G, Gelman A, Gilks W: Weak convergence and optimal scaling of random walk Metropolis algorithms. Ann Appl Probability. 1997, 7: 110-120.

    Article  Google Scholar 

  24. Fu F, Zhou Q: Learning sparse causal Gaussian networks with experimental intervention: regularization and coordinate descent. J Am Stat Assoc. 2013, 108 (501): 288-300. 10.1080/01621459.2012.754359.

    Article  CAS  Google Scholar 

  25. Hauser A, Bühlmann P: Two optimal strategies for active learning of causal models from interventions. Proc. of the 6th European Workshop on Probabilistic Graphical Models. 2012, 123-130.

    Google Scholar 

Download references

Acknowledgements

We thank Rémi Bancal for his work during his master internship, as well as the editor and two anonymous reviewers for their helpful comments and suggestions. GN received financial support from the Sorbonne Paris Cité IDEX grant “SA-flex.”

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Andrea Rau.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

AR participated in the design of the study, performed simulations and data analyses, and helped draft the manuscript. FJ participated in the design of the study and drafted the manuscript. GN designed the study, performed the analytical likelihood calculations and helped draft the manuscript. All authors read and approved the final manuscript.

Electronic supplementary material

12918_2013_1448_MOESM1_ESM.pdf

Additional file 1: Supplementary materials. This file contains details for calculations as well as additional results from the simulation study presented in the main paper. (PDF 282 KB)

12918_2013_1448_MOESM2_ESM.r

Additional file 2: R code to implement MCMC-Mallows approach. This file contains the R code to implement the proposed MCMC-Mallows approach. (R 21 KB)

12918_2013_1448_MOESM3_ESM.r

Additional file 3: Example R code to run MCMC-Mallows approach. This file contains the R code to run the proposed MCMC-Mallows approach for a set of simulated data. (R 2 KB)

Authors’ original submitted files for images

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/2.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Rau, A., Jaffrézic, F. & Nuel, G. Joint estimation of causal effects from observational and intervention gene expression data. BMC Syst Biol 7, 111 (2013). https://doi.org/10.1186/1752-0509-7-111

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1752-0509-7-111

Keywords