Abstract
Root causal gene expression levels – or root causal genes for short – correspond to the initial changes to gene expression that generate patient symptoms as a downstream effect. Identifying root causal genes is critical towards developing treatments that modify disease near its onset, but no existing algorithms attempt to identify root causal genes from data. RNA-sequencing (RNA-seq) data introduces challenges such as measurement error, high dimensionality and non-linearity that compromise accurate estimation of root causal effects even with state-of-the-art approaches. We therefore instead leverage Perturb-seq, or high throughput perturbations with single cell RNA-seq readout, to learn the causal order between the genes. We then transfer the causal order to bulk RNA-seq and identify root causal genes specific to a given patient for the first time using a novel statistic. Experiments demonstrate large improvements in performance. Applications to macular degeneration and multiple sclerosis also reveal root causal genes that lie on known pathogenic pathways, delineate patient subgroups and implicate a newly defined omnigenic root causal model.
Introduction
Genetic and non-genetic factors that cause disease can affect gene expression as an intermediate step. We introduce root causal gene expression levels – or root causal genes for short – that correspond to the initial changes to gene expression induced by genetic and non-genetic factors that generate a pathogenic cascade ultimately causing a downstream diagnosis (Figure 1). Root causal genes differ from core genes that directly affect the diagnosis and thus lie at the end, rather than at the beginning, of pathogenesis (Boyle et al., 2017). Root causal genes also generalize (the expression levels of) driver genes that only account for the effects of somatic mutations primarily in cancer (Martínez-Jiménez et al., 2020).

Toy example where a variable E2 simultaneously models genetic and non-genetic factors that cause a diagnose Y through gene expression 

Treating root causal genes can modify disease pathogenesis in its entirety, whereas targeting other causes may only provide symptomatic relief. For example, mutations in Gaucher disease cause decreased expression of wild type beta-glucocerebrosidase, or the root causal gene (Nagral, 2014). We can give a patient blood transfusions to alleviate the fatigue and anemia associated with the disease, but we seek more definitive treatments like recombinant glucocerebrosidase that replaces the deficient enzyme. Enzyme replacement therapy alleviates the associated liver, bone and neurological abnormalities of Gaucher disease as a downstream effect. Identifying root causal genes is therefore critical for developing treatments that eliminate disease near its pathogenic onset.
The problem is further complicated by the existence of complex disease, where a patient may have multiple root causal genes that differ from other patients even within the same diagnostic category (Cano-Gamez and Trynka, 2020). Complex diseases often have an overwhelming number of causes, but the root causal genes may only represent a small subset implicating a more omnigenic than polygenic model. We thus also seek to identify patient-specific root causal genes in order to classify patients into meaningful biological subgroups each hopefully dictated by only a small group of genes.
No existing method identifies root causal genes from data. Many algorithms focus on discovering associational (Costa-Silva et al., 2017) or even causal relations (Wang et al., 2023; Wen et al., 2023), but none pinpoint the first gene expression levels that ultimately generate disease. We therefore define the Root Causal Strength (RCS) score to identify root causal genes unique to each patient. We then design the Root Causal Strength using Perturbations (RCSP) algorithm that estimates RCS from bulk RNA-seq under minimal assumptions by integrating Perturb-seq, or high throughput perturbation experiments using CRISPR-based technologies coupled with single cell RNA-sequencing (Dixit et al., 2016; Adamson et al., 2016; Datlinger et al., 2017). Experiments demonstrate marked improvements in performance. Finally, application of the algorithm to two complex diseases with disparate pathogeneses simultaneously recovers root causal genes, omnigenic disease models, pathogenic pathways and drug candidates delineating patient subgroups for the first time.
Results
We briefly summarize the Methods in the first two subsections.
Definitions
Differential expression analysis identifies differences in gene expression levels between groups Y (Costa-Silva et al., 2017). A gene Xi may be differentially expressed due to multiple reasons. For example, Xi may cause Y, or a confounder C may explain the relation between Xi and Y such that Xi ← C → Y. In this paper, we take expression analysis a step further by pinpointing causal relations from expression levels regardless of the variable type of Y (discrete or continuous). We in particular seek to discover patient-specific root causal genes from bulk RNA-seq data, which we carefully define below.
We represent a biological system in bulk RNA-seq as a causal graph 𝔾 – such as in Figure 2 (a) – where p vertices 







Method overview and synthetic data results. (a) We consider a latent causal graph over the true counts 





We can associate 𝔾 with the structural equation 




We prove the last equality in the Methods. As a result, RCS Φi directly measures the contribution of the gene 



Algorithm
We propose an algorithm called Root Causal Strength using Perturbations (RCSP) that estimates Φ = {Φ1, …, Φp} from genes measured in both bulk RNA-seq and Perturb-seq datasets derived from possibly independent studies but from the same tissue type. We rely on bulk RNA-seq instead of single cell RNA-seq in order to obtain many samples of the label Y. We focus on statistical estimation rather than statistical inference because Φi > 0 when when Ei causes Y under mild conditions, so we reject the null hypothesis that Φi = 0 for many genes if many gene expression levels cause Y. However, we hypothesize that Φi ≫ 0 for a small subset of genes in each patient under an omnigenic model, which we seek to estimate.
Estimating Φ requires access to the true gene expression levels 
We in particular show that Φi in Equation (1) is also equivalent to:

where 





In silico identification of root causal genes
We simulated 30 bulk RNA-seq and Perturb-seq datasets from random directed graphs summarizing causal relations between gene expression levels. We performed single gene knock-down perturbations over 2500 genes and 100 batches. We obtained 200 cell samples from each perturbation, and another 200 controls without perturbations. We therefore generated a total of 2501 × 200 = 500, 200 single cell samples for each Perturb-seq dataset. We simulated 200 bulk RNA-seq samples. We compared RCSP against the Additive Noise Model (ANM) (Peters et al., 2014; Strobl and Lasko, 2023a), the Linear Non-Gaussian Acyclic Model (LiNGAM) (Peters et al., 2014; Strobl and Lasko, 2022), CausalCell (Wen et al., 2023), univariate regression residuals (Uni Reg), and multivariate regression residuals (Multi Reg). The first two algorithms are state-of-the-art approaches used for error term extraction and, in theory, root causal discovery. See Methods for comprehensive descriptions of the simulation setup and comparator algorithms.
We summarize accuracy results in Figure 2 (g) using the Root Mean Squared Error (RMSE) to the ground truth Φ values. All statements about pairwise differences hold true at a Bonferonni corrected threshold of 0.05/5 according to paired two-sided t-tests, since we compared a total of five algorithms. RCSP estimated Φ most accurately by a large margin. ANM and LiNGAM are theoretically correct under their respective assumptions, but they struggle to outperform standard multivariate regression due to the presence of measurement error in RNA-seq (Supplementary Materials). Feature selection and causal discovery with CausalCell did not improve performance. Univariate regression performed the worst, since it does not consider the interactions between variables. RCSP achieved the lowest RMSE while completing in about the same amount of time as multivariate regression on average (Figure 2 (h)). We conclude that RCSP both scalably and accurately estimates Φ from a combination of bulk RNA-seq and Perturb-seq data.
We will cluster the RCS values in real data to find patient subgroups. We therefore also performed hierarchical clustering using Ward’s method (Ward Jr, 1963) on the values of Φ estimated by RCSP with the synthetic data. We then computed the RMSE within each cluster and averaged the RMSEs between clusters. We found that RCSP maintained low average RMSE values regardless of the number of clusters considered (Figure 2 (i)). We conclude that RCSP maintains accurate estimation of Φ across different numbers of clusters.
Oxidative stress in age-related macular degeneration
We ran RCSP on a bulk RNA-seq dataset of 513 individuals with age-related macular degeneration (AMD; GSE115828) and a Perturb-seq dataset of 247,914 cells generated from an immortalized retinal pigment epithelial (RPE) cell line (Ratnapriya et al., 2019; Replogle et al., 2022). The Perturb-seq dataset contains knockdown experiments of 2077 genes overlapping with the genes of the bulk dataset. We set the target Y to the Minnesota Grading System score, a measure of the severity of AMD based on stereoscopic color fundus photographs. We always included age and sex as a biological variable as covariates. We do not have access to the ground truth values of Φ in real data, so we evaluated RCSP using seven alternative techniques. See Methods for a detailed rationale of the evaluation of real data. RCSP outperformed all other algorithms in this dataset (Supplementary Materials). We therefore only analyze the output of RCSP in detail here.
AMD is a neurodegenerative disease of the aging retina (Hadziahmetovic and Malek, 2021), so age is a known root cause of the disease. We therefore determined if RCSP identified age as a root cause. Note that RCSP does not need perturbation data of age to compute the RCS values of age, since age has no parents in the directed graph. The algorithm estimated a heavy tailed distribution of the RCS values indicating that most of the RCS values deviated away from zero (Figure 3 (a)). The Deviation of the RCS (D-RCS), or the standard deviation from an RCS value of zero, measures the tailedness of the distribution while preserving the unit of measurement. The D-RCS of age corresponded to 0.46 – more than double that of the nearest gene (Figure 3 (d)). We conclude that RCSP correctly detected age as a root cause of AMD.

Analysis of AMD. (a) The distribution of the RCS scores of age deviated away from zero and had a composite D-RCS of 0.46. (b) However, the majority of gene D-RCS scores concentrated around zero, whereas the majority of gene D-SD scores concentrated around the relatively larger value of 0.10. Furthermore, the D-RCS scores of the genes in (d) mapped onto the “amino acid transport across the plasma membrane” pathway known to be involved in the pathogenesis of AMD in (c). Blue bars survived 5% FDR correction. (e) Drug enrichment analysis revealed four significant drugs, the later three of which have therapeutic potential. (f) Hierarchical clustering revealed four clear clusters according to the elbow method, which we plot by UMAP dimensionality reduction in (g). The RCS scores of the top genes in (d) increased only from the left to right on the first UMAP dimension (x-axis); we provide an example of SLC7A5 in (h) and one of three detected exceptions in (i). We therefore performed pathway enrichment analysis on the black cluster in (g) containing the largest RCS scores. (j) The amino acid transport pathway had a larger degree of enrichment in the black cluster as compared to the global analysis in (c).
Root causal genes typically affect many downstream genes before affecting Y. We therefore expect to identify few root causal genes but many genes that correlate with Y. To evaluate this hypothesis, we examined the distribution of D-RCS relative to the distribution of the Deviation of Statistical Dependence (D-SD), or the standard deviation from an SD value of zero, in Figure 3 (b). Few D-RCS scores had large values implying the existence of only a few significant root causal genes. In contrast, most of the D-SD scores had relatively larger values concentrated around 0.10 implying the existence of many genes correlated with Y. We conclude that RCSP identified few root causal genes rather than many correlated genes for AMD.
The pathogenesis of AMD involves the loss of RPE cells. The RPE absorbs light in the back of the retina, but the combination of light and oxygen induces oxidative stress, and then a cascade of events such as immune cell activation, cellular senescence, drusen accumulation, neovascularization and ultimately fibrosis (Barouch and Miller, 2007). We therefore expect the root causal genes of AMD to include genes involved in oxidative stress. The gene MIPEP with the highest D-RCS score in Figure 3 (d) indeed promotes the maturation of oxidative phosphorylation-related proteins (Shi et al., 2011). The second gene SLC7A5 is a solute carrier that activates mTORC1 whose hyperactivation increases oxidative stress via lipid peroxidation (Nachef et al., 2021; Go et al., 2020). The gene HEATR1 is involved in ribosome biogenesis that is downregulated by oxidative stress (Turi et al., 2018). The top genes discovered by RCSP thus identify pathways known to be involved in oxidative stress.
We subsequently jointly analyzed the D-RCS values of all 2077 genes. We performed pathway enrichment analysis that yielded one pathway “amino acid transport across the plasma membrane” that passed an FDR threshold of 5% (Figure 3 (c)). The leading edge genes of the pathway included the solute carriers SLC7A5 and SLC1A5. These two genes function in conjunction to increase the efflux of essential amino acids out of the lysosome (Nicklin et al., 2009; Beaumatin et al., 2019). Some of these essential amino acids like L-leucine and L-arginine activate mTORC1 that in turn increases lipid peroxidation induced oxidative stress and the subsequent degeneration of the RPE (Nachef et al., 2021; Go et al., 2020). We conclude that pathway enrichment analysis correctly identified solute carrier genes involved in a known pathway promoting oxidative stress in AMD.
We next ran drug enrichment analysis with the D-RCS scores. The top compound arsenous acid inhibits RPE proliferation (Su et al., 2020), but the other three significant drugs have therapeutic potential (Figure 3 (e)). Busulfan decreases the requirement for intravitreal anti-VEGF injections (Dalvin et al., 2022). Genistein is a protein kinase inhibitor that similarly attenuates neovascularization (Kinoshita et al., 2014) and blunts the effect of ischemia on the retina (Kamalden et al., 2011). Finally, a metabolite of the antiviral agent 3’-azido-3’-deoxythymidine inhibits neovascularization and mitigates RPE degeneration (Narendran et al., 2020). We conclude that the D-RCS scores identified promising drugs for the treatment of AMD.
Hierarchical clustering and UMAP dimensionality reduction on the patient-specific RCS values revealed four clear clusters of patients by the elbow method on the sum of squares plot (Figures 3 (f) and (g), respectively). Most of the top genes exhibited a clear gradation increasing only from the left to the right hand side of the UMAP embedding; we plot an example in Figure 3 (h). We found three exceptions to this rule among the top 30 genes (example in Figure 3 (i) and see Supplementary Materials). RCSP thus detected genes with large RCS scores primarily in the black cluster of Figure 3 (g). Pathway enrichment analysis within this cluster alone yielded supra-significant results on the same pathway detected in the global analysis (Figure 3 (j) versus Figure 3 (c)). Furthermore, clusterwise drug enrichment analysis results confirmed that patients in the black cluster with many root causal genes are likely the hardest to treat (Supplementary Materials). We conclude that RCSP detected a subgroup of patients whose root causal genes have large RCS scores and involve known pathogenic pathways related to oxidative stress.
T cell infiltration in multiple sclerosis
We next ran RCSP on 137 samples collected from CD4+ T cells of multiple sclerosis (MS; GSE137143) as well as Perturb-seq data of 1,989,578 lymphoblasts, or the precursors of T cells and other lymphocytes (Kim et al., 2021; Replogle et al., 2022). We set the target Y to the Expanded Disability Status Scale score, a measure of MS severity. RCSP outperformed all other algorithms in this dataset as well (Supplementary Materials).
MS progresses over time, and RCSP correctly detected age as a root cause of MS severity with RCS values deviating away from zero (Figure 4 (a)). The distribution of gene D-RCS scores concentrated around zero, whereas the distribution of gene D-SD scores concentrated around a relatively larger value of 0.3 (Figure 4 (b)). RCSP thus detected an omnigenic root causal model rather than a polygenic correlational model.

Analysis of MS. (a) The distribution of the RCS scores of age deviated away from zero with a composite D-RCS of 0.55. (b) The distribution of D-RCS concentrated around zero, whereas the distribution of D-SD concentrated around 0.3. (d) RCSP identified many genes with large D-RCS scores that in turn mapped onto known pathogenic pathways in MS in (c). Hierarchical clustering revealed three clusters in (e), which we plot in two dimensions with UMAP in (f). Top genes did not correlate with either dimension of the UMAP embedding; we provide an example of the MNT gene in (g). (h) Drug enrichment analysis in the green cluster implicated multiple cathepsin inhibitors. Finally, EPH-ephrin signaling survived FDR correction in (c) and was enriched in the pink cluster in (i) which contained more MS patients with the relapsing-remitting subtype in (j); subtypes include relapse-remitting (RR), primary progressive (PP), secondary progressive (SP), clinically isolated syndrome (CIS), and radiologically isolated syndrome (RIS).
MS is an inflammatory neurodegenerative disease that damages the myelin sheaths of nerve cells in the brain and spinal cord. T cells may mediate the inflammatory process by crossing a disrupted blood brain barrier and repeatedly attacking the myelin sheaths (Fletcher et al., 2010). Damage induced by the T cells also perturbs cellular homeostasis and leads to the accumulation of misfolded proteins (Andhavarapu et al., 2019). The root causal genes of MS thus likely include genes involved in T cell infiltration across the blood brain barrier.
Genes with the highest D-RCS scores included MNT, CERCAM and HERPUD2 (Figure 4 (d)). MNT is a MYC antagonist that modulates the proliferative and pro-survival signals of T cells after engagement of the T cell receptor (Gnanaprakasam and Wang, 2017). Similarly, CERCAM is an adhesion molecule expressed at high levels in microvessels of the brain that increases leukocyte transmigration across the blood brain barrier (Starzyk et al., 2000). HERPUD2 is involved in the endoplasmic-reticulum associated degradation of unfolded proteins (Kokame et al., 2000). Genes with the highest D-RCS scores thus serve key roles in known pathogenic pathways of MS.
We found multiple genes with high D-RCS scores in MS, in contrast to AMD where age dominated (Figure 4 (d) versus Figure 3 (d)). We performed pathway enrichment analysis using the D-RCS scores of all genes and discovered two significant pathways at an FDR corrected threshold of 5%: “adenomatous polyposis coli (APC) truncation mutants have impaired AXIN binding” and “EPH-ephrin signaling” (Figure 4 (c)). APC and AXIN are both members of the Wnt signaling pathway and regulate levels of beta-catenin (Spink et al., 2000). Furthermore, inhibition of Wnt/beta-catenin causes CD4+ T cell infiltration into the central nervous system via the blood brain barrier in MS (Lengfeld et al., 2017). Ephrins similarly regulate T cell migration into the central nervous system (Luo et al., 2016) and are overexpressed in MS lesions (Sobel, 2005). The APC-AXIN and EPH-ephrin pathways are thus consistent with the known pathophysiology of central nervous system T cell infiltration in MS.
We subsequently performed hierarchical clustering of the RCS scores. The within cluster sum of squares plot in Figure 4 (e) revealed the presence of three clusters by the elbow method. We plot the three clusters in a UMAP embedding in Figure 4 (f). The clusters did not show a clear relationship with MS symptom severity (Supplementary Materials) or the levels of the top most genes of Figure 4 (d); we plot the MNT gene as an example in Figure 4 (g). However, further analyses with additional genes revealed that the distribution of many lower ranked genes governed the structure of the UMAP embedding (Supplementary Materials). The D-RCS scores of each cluster also implicated different mechanisms of T cell pathology including APC-AXIN in the green cluster, disturbed T cell homeostasis in the pink cluster and platelet enhanced T cell autoreactivity in the blue cluster (Supplementary Materials).
Global drug enrichment analysis did not yield any significant drugs even at a liberal FDR threshold of 10%. We thus ran drug enrichment analysis in each cluster of Figure 4 (f). The blue and pink clusters again did not yield significant drugs. However, the third green cluster identified the cysteine cathepsin inhibitors dipeptide-derived nitriles, phenylalinine derivatives, e-64, L-006235 and L-873724 (Figure 4 (h)); statistical significance of the first three held even after correcting for multiple comparisons with the Bonferroni adjustment of 0.05/4 on the q-values. The leading edge genes of the significant drugs included the cathepsins CTSL, CTSS and CTSB exclusively. These drug enrichment results corroborate multiple experimental findings highlighting the therapeutic efficacy of cathepsin inhibitors in a subgroup of MS patients responsive to interferon therapy (Haves-Zburof et al., 2011; Burster et al., 2007).
Prior research has also shown that EPH-ephrin signaling is more prevalent in relapsing-remitting multiple sclerosis than in other subtypes of the disease (Golan et al., 2021). EPH-ephrin signaling survived FDR correction in our analysis (Figure 4 (c)). Furthermore, the pathway was more enriched in the pink cluster than in the other two (Figure 4 (i)). The pink cluster indeed contained a higher proportion of patients with the relapsing-remitting subtype (Figure 4 (j)). RCSP thus precisely identified the enrichment of EPH-ephrin signaling in the correct subtype of MS.
Discussion
We presented a framework for identifying root causal genes using the error terms of structural equation models. Each error term represents the conglomeration of unobserved root causes, such as genetic variants or environmental conditions, that only modulate a specific gene. We however do not have access to many of the error terms in practice, so we introduced the root causal strength (RCS) score that detects root causal genes from bulk RNA-seq without recovering the error term values as an intermediate step. The RCSP algorithm computes RCS given knowledge of the causal ancestors of each variable, which we obtained by Perturb-seq. RCSP only transfers the causal structure (binary cause-effect relations) from the single cell to bulk data rather than the exact functional relationships in order to remain robust against discrepancies between the two data types. Results with the synthetic data demonstrated marked improvements over existing alternatives. The algorithm also recovered root causal genes that play key roles in known pathogenic pathways and implicate therapeutic drugs in both AMD and MS.
We detected a modest number of root causal genes in both AMD and MS relative to the number of genes correlated with Y. This omnigenic model differs from the omnigenic model involving core genes (Boyle et al., 2017). Boyle et al. define core genes as genes that directly affect disease risk and play specific roles in disease etiology. In contrast, root causal genes may not directly affect Y but lie substantially upstream of Y in the causal graph. Boyle et al. further elaborate that many peripheral genes affect the functions of a modest number of core genes, so the peripheral genes often explain most of disease heritability. Causation from root causal genes moves in the opposite direction – the error terms of upstream root causal genes causally affect many downstream genes that include both ancestors and non-ancestors of Y. These downstream genes contain traces of the root causal gene error terms that induce the many correlations with Y. The error terms of root causal genes associated with large RCS scores also mix with the error terms of the other ancestors of Y with small RCS scores leading to Fisher’s classic infinitesimal model (Fisher, 1919). The indirect effects of root causal genes on Y and the impact of root causal genes on many downstream genes correlated with Y motivate us to use the phrase omnigenic root causal model in order to distinguish it from the omnigenic core gene model.
We identified root causal genes without imposing parametric assumptions using the RCS metric. Prior measures of root causal effect require restrictive functional relations, such as linear relations or additive noise, and continuous random variables (Strobl and Lasko, 2022; Strobl et al., 2023; Strobl and Lasko, 2023a). These restrictions ensure exact identifiability of the underlying causal graph and error terms. However, real RNA-seq is obtained from a noisy sequencing process and contains count data arguably corrupted by Poisson measurement error (Sarkar and Stephens, 2021). The Poisson measurement error introduces confounding that precludes exact recovery of the underlying error terms. The one existing root causal discovery method that can handle Poisson measurement error uses single cell RNA-seq, estimates negative binomial distribution parameters and cannot scale to the thousands of genes required for meaningful root causal detection (Strobl and Lasko, 2023b). RCSP rectifies the deficiencies of these past approaches by ensuring accurate root causal detection even in the presence of the counts, measurement error and high dimensionality of RNA-seq.
This study carries limitations worthy of addressing in future work. The RCS score importantly quantifies root causal strength rather than root causal effect. As a result, the method cannot be used to identify the direction of root causal effect unconditional on the parents. The root causal effect and RCS do not differ by much in practice (Supplementary Materials), but future work should focus on exactly identifying both the strength and direction of the causal effects of the error terms. Furthermore, RCS achieves patient but not cell-specificity because the algorithm relies on phenotypic labels obtained from bulk RNA-seq. RCSP thus cannot identify the potentially different root causal genes present within distinct cell populations. Third, RCSP accounts for known batch effects and measurement error but cannot adjust for unknown confounding. Finally, RCSP assumes a directed acyclic graph. We can transform a directed graph with cycles into an acyclic one under equilibrium, but real biological distributions vary across time (Spirtes, 1995; Bongers et al., 2021). Future work should thus aim to estimate cell-specific root causal effects under latent confounding and time-varying distributions.
In conclusion, RCSP integrates bulk RNA-seq and Perturb-seq to identify patient-specific root causal genes under a principled causal inference framework using the RCS score. RCS quantifies root causal strength implicitly without requiring normalization by sequencing depth or direct access to the error terms of a structural equation model. The algorithm identifies the necessary causal relations to compute RCS using reliable high throughput perturbation data rather than observational data alone. The RCS scores often suggest an omnigenic rather than a polygenic root causal model of disease. Enrichment analyses with the RCS scores frequently reveal pathogenic pathways and drug candidates. We conclude that RCSP is a novel, accurate, scalable and disease-agnostic procedure for performing patient-specific root causal discovery.
Methods and Materials
Background on Causal Discovery
We denote a singleton variable like 



where fi is a function of the parents, or direct causes, of Zi and an error term Ei ∈ E. The error terms E are mutually independent. We will use the terms vertex and variable interchangeably. A root vertex corresponds to a vertex without any parents. On the other hand, a terminal vertex is not a parent of any other vertex.
We can associate a directed graph to Z by drawing a directed edge from each member of Pa(Zi) to Zi for all Zi ∈ Z. A directed path from Zi to Zj corresponds to a sequence of adjacent directed edges from Zi to Zj. If such a path exists (or Zi = Zj), then Zi is an ancestor of Zj and Zj is a descendant of Zi. We collate all ancestors of Zi into the set Anc(Zi). A cycle occurs when there exists a directed path from Zi to Zj and the directed edge Zj → Zi. A directed acyclic graph (DAG) contains no cycles. We augment a directed graph by including additional vertices E and drawing a directed edge from each Ei ∈ E to Xi except when Xi = Ei is already a root vertex. We consider an augmented DAG 𝔾 throughout the remainder of this manuscript.
The vertices Zi and Zj are d-connected given W ⊆ Z \{Zi, Zj } in 𝔾 if there exists a path between Zi and Zj such that every collider on the path is an ancestor of W and no non-collider is in W. The vertices are d-separated if they are not d-connected. Any DAG associated with the SEM in Equation (3) also obeys the global Markov property where Zi and Zj are conditionally independent given W if they are d-separated given W. The term d-separation faithfulness refers to the converse of the global Markov property where conditional independence implies d-separation. A distribution obeys unconditional d-separation faithfulness when we can only guarantee d-separation faithfulness when W = ∅.
Causal Modeling of RNA Sequencing
Performing causal discovery requires careful consideration of the underlying generative process. We therefore propose a causal model for RNA-seq. We differentiate between the biology and the RNA sequencing technology.
We represent a biological causal process using an SEM over 


We derive the measurement error distribution from first principles. We map an exceedingly small fraction of each 



We write the probability of mapping 

This proportion remains virtually unchanged when sampling without replacement because 




We conclude that the measurement error distribution follows a Poisson distribution to high accuracy. Multiple experimental results already corroborate this theoretical conclusion (Grün et al., 2014; Sarkar and Stephens, 2021; Choudhary and Satija, 2022).
We can represent the biology and the RNA sequencing in a single DAG over 



An example of a DAG over 
No Need for Normalization by Sequencing Depth
We provide an asymptotic argument that eliminates the need for normalization by sequencing depth when estimating conditional expectations using bulk RNA-seq. The argument applies to the conditional expectations as a whole rather than their individual parameters.
We want to recover the causal relations between 






where we have divided 
We do not divide by L in practice because we may have L = 0 with finite N. We instead always include L ∪ B in the predictor set of downstream regressions. Conditioning on L ∪ B ensures that all downstream regressions mitigate depth and batch effects with adequate sequencing depth, or that 

Lemma 1.
Assume Lipschitz continuity of the conditional expectation for all N ≥ n0 :

where 

We delegate proofs to the Supplementary Materials unless proven here in the Methods. Note that 


We now eliminate the need to condition on L. Note that L is a sum of independent Poisson distributions given B per Expression (4). This implies 

Theorem 1.
Consider the same assumption as Lemma 1. Then 
We emphasize again that these equalities hold for the conditional expectation but not for the regression parameters; the regression parameters do not converge in general unless we divide by L. We will only need to estimate conditional expectations in order to identify root causal genes.
Identifying Root Causal Genes
We showed how to overcome Poisson measurement error without sequencing depth normalization in the previous section. We leverage this technique to define a measure for identifying the root causal genes of Y.
Definitions
A root cause of Y corresponds to a root vertex that is an ancestor of Y in 𝔾. All root vertices are error terms in an augmented graph. We define the root causal effect of any Ei∈ E on Y as γi ≜ ℙ(Y| Ei) − ℙ(Y) (Strobl, 2024; Strobl and Lasko, 2023c).
We can identify root causes using the following result:
Proposition 1.
If 

We can also claim the backward direction under d-separation faithfulness. We however avoid making this additional assumption because real biological data may not arise from distributions obeying d-separation faithfulness in practice (Strobl, 2022).
Proposition 1 implies that Ei is a root cause of Y when:

However, Δi does not correspond to the root causal effect γi due to the extra conditioning on 
We now encounter two challenges. First, the quantities γi and Δi depend on the unknown error term Ei. We can however substitute Ei with 
Proposition 2.
We have 
We can thus compute Δi without access to the error terms:

The ability to determine the root causal status of Ei on Y when Δi ≠ 0 per Proposition 1, and the above ability to directly substitute Ei with its gene 

The second challenge involves computing the non-parametric probability distributions of Δi which come at a high cost. We thus define the analogous expected version by:

where p(Y) denotes the density of Y. Observe that if Δi = 0, then Γi = 0. The converse is not true but likely to hold in real data when a change in the probability distribution also changes its expectation. The set 


We call Φi ≜ |Γi| the Root Causal Strength (RCS) of 



Algorithm
We now design an algorithm called Root Causal Strength using Perturbations (RCSP) that recovers the RCS scores using Perturb-seq and bulk RNA-seq data.
Finding Surrogate Ancestors
Computing Φi for each 
We instead directly utilize the interventional Perturb-seq data to recover a superset of the surrogate parents. We first leverage the global Markov property and equivalently write:

where 


We discover the surrogate ancestors using unconditional independence tests. For any Xk ∈ X, we test 





Procedure
We now introduce an algorithm called Root Causal Strength using Perturbations (RCSP) that discovers the surrogate ancestors of each variable 
RCSP takes Perturb-seq and bulk RNA-seq datasets as input. The algorithm first finds the surrogate descendants of each variable in 
Algorithm 1 Root Causal Strength using Perturbations (RCSP) Algorithm 1 Root Causal Strength using Perturbations (RCSP)

We certify RCSP as follows:
Theorem 2.
(Fisher consistency) Consider the same assumption as Lemma 1. If unconditional d-separation faithfulness holds, then RCSP recovers Φ almost surely as N → ∞.
We engineered RCSP to only require unconditional d-separation faithfulness because real distributions may not obey full d-separation faithfulness (Strobl, 2022).
Synthetic Data
Simulations
We generated a linear SEM obeying Equation (3) specifically as 






Comparators
We compared RCSP against the following four algorithms:
- Additive noise model (ANM) (Peters et al., 2014; Strobl and Lasko, 2023a): performs non-linear regression of Xi on Pa(Xi) ∪ B and then regresses Y on the residuals E \ Ei to estimate |𝔼(Y|E \ Ei) − 𝔼(Y |X, B) | for each Xi ∈ X. The non-linear regression residuals are equivalent to the error terms assuming an additive noise model. 
- Linear Non-Gaussian Acyclic Model (LiNGAM) (Peters et al., 2014; Strobl and Lasko, 2022): same as above but performs linear instead of non-linear regression. 
- CausalCell (Wen et al., 2023): selects the top 50 genes with maximal statistical dependence to Y, and then runs the Peter-Clark (PC) algorithm (Spirtes et al., 2000) using a non-parametric conditional independence test to identify a causal graph among the top 50 genes. The algorithm does not perform root causal inference, so we use ANM as above but condition on the estimated parent sets for the top 50 genes and the ancestors inferred from the Perturb-seq data otherwise. 
- Univariate regression residuals (Uni Reg): regresses Y on Xi ∪ B and estimates the absolute residuals |Y − 𝔼(Y|Xi, B) | for each Xi ∈ X. 
- Multivariate regression residuals (Multi Reg): similar to above but instead computes the absolute residuals after regressing Y on (X \ Xi) ∪ B. 
The first two methods are state-of-the-art approaches used for root causal discovery. Univariate and multivariate regressions do not distinguish between predictivity and causality, but we included them as sanity checks. We performed all non-linear regressions using multivariate adaptive regression splines to control for the underlying regressor (Friedman, 1991). We compared the algorithms on their accuracy in estimating Φ.
Real Data
Quality Control
We downloaded Perturb-seq datasets of retinal pigment epithelial cells from the RPE-1 cell line, and lymphoblast cells from the K562 cell line (Replogle et al., 2022). We used the genome-wide dataset version for the latter. We downloaded the datasets from the scPerturb database on Zenodo (Green et al., 2022) with the same quality controls as the original paper. Replogle et al. computed adjusted library sizes by equalizing the mean library size of control cells within each batch. Cells with greater than a 2000 or 3000 library size, and less than 25% or 11% mitochondrial RNA were kept, respectively. The parameters were chosen by plotting the adjusted library sizes against the mitochondrial RNA counts and then manually setting thresholds that removed low quality cells likely consisting of ambient mRNA transcripts arising from premature cell lysis or cell death.
We next downloaded bulk RNA-seq datasets derived from patients with age-related macular degeneration (AMD; GSE115828) and multiple sclerosis (MS; GSE137143) (Ratnapriya et al., 2019; Kim et al., 2021). We excluded 10 individuals from the AMD dataset including one with an RNA integrity number of 21.92, five missing an integrity number (all others had an integrity number of less than 10), and four without a Minnesota Grading System score. We kept all samples from the MS dataset derived from CD4+ T cells but filtered out genes with a mean of less than 5 counts as done in the original paper.
We finally kept genes that were present in both the AMD bulk dataset and the RPE-1 Perturb-seq dataset, yielding a final count of 513 bulk RNA-seq samples and 247,914 Perturb-seq samples across 2077 genes. We also kept genes that were present in both the MS bulk dataset and the K562 Perturb-seq dataset, yielding a final count of 137 bulk RNA-seq samples and 1,989,578 Perturb-seq samples across 6882 genes. We included age and sex as a biological variable as covariates for every patient in both datasets in subsequent analyses.
Evaluation Rationale
We do not have access to the ground truth values of Φ in real data. We instead evaluate the RCSP estimates of Φ using alternative sources of ground truth knowledge. We first assess the accuracy of RCS using the control variable age as follows:
- Determine if the RCS values of age identify age as a root cause in diseases that progress over time. - Second, root causal genes should imply a more omnigenic than polygenic model because the effects of a few error terms distribute over many downstream genes. We verify omnigenecity as follows: 
- Determine if the distribution of D-RCS concentrates around zero more than the distribution of the Deviation of Statistical Dependence (D-SD) defined as   - Despite the sparsity/omnigenecity of root causal genes, we still expect the root causal genes to correspond to at least some known causes of disease: 
- Determine if genes with the top D-RCS scores correspond to genes known to cause the disease. - Next, the root causal genes initiate pathogenesis, and we often have knowledge of pathogenic pathways even though we may not know the exact gene expression cascade leading to disease. Intervening on root causal genes should also modulate patient symptoms. We thus further evaluate the accuracy of RCSP using pathway and drug enrichment analyses as follows: 
- Determine if the D-RCS scores identify known pathogenic pathways of disease in pathway enrichment analysis. 
- Determine if the D-RCS scores identify drugs that treat the disease. - Finally, complex diseases frequently involve multiple pathogenic pathways that differ between patients. Patients with the same complex disease also respond differently to treatment. We hence evaluate the precision of RCS as follows: 
- Determine if the patient-specific RCS scores identify subgroups of patients involving different but still known pathogenic pathways. 
- Determine if the patient-specific RCS scores identify subgroups of patients that respond differently to drug treatment. 
In summary, we evaluate RCSP in real data based on its ability to (1) identify age as a known root cause, (2) suggest an omnigenic root causal model, (3) recover known causal genes, (4) find known pathogenic pathways, (5) find drugs that treat the disease, and (6,7) delineate patient subgroups.
Enrichment Analyses
Multivariate adaptive regression splines introduce sparsity, but enrichment analysis performs better with a dense input. We can estimate the conditional expectations of Φ using any general non-linear regression method, so we instead estimated the expectations using kernel ridge regression equipped with a radial basis function kernel (Shawe-Taylor and Cristianini, 2004). We then computed the D-RCS across all patients for each variable in X. We ran pathway enrichment analysis using the fast gene set enrichment analysis (FGSEA) algorithm (Sergushichev, 2016) with one hundred thousand simple permutations using the D-RCS scores and pathway information from the Reactome database (version 1.86.0) (Fabregat et al., 2017). We likewise performed drug set enrichment analysis with the Drug Signature database (version 1.0) (Yoo et al., 2015). We repeated the above procedures for the D-RCS of any cluster identified by hierarchical clustering via Ward’s method (Ward Jr, 1963).
Data Availability
All datasets analyzed in this study have been previously published and are publicly accessible as follows:
Code Availability
R code needed to replicate all experimental results is available on GitHub.
Acknowledgements
Research reported in this report was supported by the National Human Genome Research Institute of the National Institutes of Health under award numbers R01HG011138 and R35HG010718.
Supplementary Materials
Normalization by Sequencing Depth
We theoretically showed that RCS does not require normalization by sequencing depth in the Methods using an asymptotic argument. We tested this claim empirically by drawing 200 bulk RNA-seq samples from random DAGs as in the Methods but over p + 1 = 250 variables. We varied the mean sequencing depth N/p of each gene from 15, 20, 30, 50, 90, 170, 330 to 650 counts; multiplying N/p by p recovers the library size N. We only included one batch in the bulk RNA-seq in order to isolate the effect of sequencing depth. We compared no normalization, normalization by 10 housekeeping genes, normalization by 20 housekeeping genes, and normalization by library size. We repeated each experiment 100 times and thus generated a total of 100 × 4 × 8 = 3200 datasets.
We plot the results in Supplementary Figure 1. All methods improved with increasing mean sequencing depth as expected. The no normalization strategy performed the best at low mean sequencing depths, followed by the housekeeping genes and then total library size. The result even held with a small library size of N = 15 × 249 = 3735 at the smallest mean sequencing depth of 15, suggesting that the asymptotic argument holds well in bulk RNA-seq where N/p is often greater than 500 and N greater than the tens of millions. However, the average RMSEs of all normalization methods became more similar as sequencing depth increased. We conclude that normalization by sequencing depth exceeds or matches the accuracy of other strategies. We therefore do not normalize by sequencing depth in subsequent analyses.

Mean RMSE to the ground truth RCS values across different mean sequencing depths and normalization strategies. The no normalization strategy achieved low RMSEs at lower mean sequencing depths, but the performances of all methods converged as the mean sequencing depths increased. Error bars denote 95% confidence intervals of the mean RMSE.
Root Causal Effect versus Signed Root Causal Strength
We compared the root causal effects Γ and the signed RCS, or Δ. The two quantities are not equivalent, but they are similar. We empirically investigated the differences between the estimated values of Δ and the true values of Γ using the RMSE and also the percent of samples with incongruent signs; Δ and Γ have incongruent signs if one is positive and the other is negative. We again drew 200 bulk RNA-seq samples from random DAGs as in the Methods over p+1 = 250 variables with one batch. We varied the bulk RNA-seq sample size from 100, 200, 400 to 800. We also compared true Δ against true Γ by estimating the two to negligible error using 20,000 samples of 
We summarize the results in Supplementary Figure 2. The estimated Δ values approached the true Γ values with increasing sample sizes. The true Δ values did not converge exactly to the true Γ values, but the RMSE remained low at 0.05 and the two values differed in sign only around 5.3% of the time. Increasing the number of samples of 

Mean RMSE (blue, left) and percent sign incongruence (green, right) of RCE and signed RCS values, respectively. The RMSE continues to decrease with increasing sample size but reaches a floor of around 0.05. Similarly, the percent sign incongruence decreases but reaches a floor of around 5%.
Functional Causal Models and Measurement Error
The experiments in the Results section quantify the accuracies of the algorithms in estimating Φ. However, the functional causal models ANM and LiNGAM also estimate the error terms as an intermediate step, whereas RCSP does not. We therefore also investigated the accuracies of ANM and LiNGAM in estimating the error term values.
Theoretical results suggest that ANM and LiNGAM cannot consistently estimate the error terms in RNA-seq due to the Poisson measurement error. We empirically tested this hypothesis by sampling from bulk RNA-seq data as in the Methods but with p + 1 = 100 and a batch size of one in order to isolate the effect of measurement error. We repeated the experiment 100 times for bulk RNA-seq sample sizes of 100, 200, 400, 800, 1600 and 3200. We plot the results in Supplementary Figure 3. The accuracies of ANM and LiNGAM did not improve beyond an RMSE of 0.44 even with a large sample size of 6400. We conclude that ANM and LiNGAM cannot estimate the error terms accurately in the presence of measurement error even with large sample sizes.

Mean RMSE values to the ground truth error term values across different sample sizes. The accuracies of ANM and LiNGAM do not improve with increasing sample sizes.
Additional Results for Age-related Macular Degeneration
Algorithm Comparisons
We say that an algorithm performs well in real data if it simultaneously (1) identifies an omnigenic model, (2) recovers known pathogenic pathways with high specificity measured by the sparsity of leading edge genes, and (3) clusters patients into clear subgroups.
We compared the algorithms with the AMD data. We summarize the results in Supplementary Figure 4 plotted on the next page. The first column denotes the standard deviation of the outputs for each algorithm. We standardized the outputs to have mean zero and unit variance. We then added the minimum value so that all histograms begin at zero. Only the RCSP algorithm had a histogram with large probability mass centered around zero. Incorporating feature selection and causal discovery with CausalCell introduced more outliers in the histogram of ANM. We conclude that only RCSP detected an omnigenic root causal model.
We plot the results of pathway enrichment analysis in the second column of Supplementary Figure 4. RCSP, LiNGAM and univariate regression detected pathways related to oxidative stress in AMD. However, the “mitotic prometaphase” and “DNA strand elongation” pathways in blue for LiNGAM involved 94 and 27 leading edge genes, respectively. The “cellular responses to stimuli” and “signal transduction” pathways for multivariate regression also involved 253 and 282 leading edge genes. In contrast, the “amino acid plasma membrane transport” pathway for RCSP involved two leading edge genes. We conclude that RCSP identified a known pathogenic pathway of AMD with the fewest number of leading edge genes.
We finally plot the clustering results in the third column of Supplementary Figure 4. The RCSP sum of squares plot revealed a sharp elbow at four groups of patients, whereas the other plots did not reveal a clear number of categories using the elbow method. We conclude that only RCSP identified clear subgroups of patients in AMD.
In summary, RCSP detected the most omnigenic model, identified pathogenic pathways with maximal specificity and discovered distinguishable patient subgroups. We therefore conclude that RCSP outperformed all other algorithms in the AMD dataset.

Comparison of the algorithms in age-related macular degeneration.
Biological Results
We provide the full pathway enrichment analysis results in Supplementary Table 1 corresponding to Figure 3 (c). We summarize pathway enrichment analysis of the black cluster of Figure 3 (g) in Figure 3 (j). However, analyses of the blue, green and pink clusters did not yield significant pathways even at a liberal FDR threshold of 10%.
We examined whether the clusters of Figure 3 (g) differentiate dry and wet macular degeneration. Wet macular degeneration is associated with the highest Minnesota Grading System (MGS) score of 4 (Olsen and Feng, 2004). We plotted the UMAP embedding against MGS (Supplementary Figure 5 (a)). None of the two UMAP dimensions correlated significantly with the MGS score (5% uncorrected threshold by Spearman’s correlation test). These results and the large RCS scores of age in Figure 3 (a) seem to support the hypothesis that wet macular degeneration is a more severe type of dry macular degeneration. However, MGS does not differentiate between wet macular degeneration and late stage dry macular degeneration involving geographical atrophy. We therefore cannot separate late stage dry and wet macular degeneration using the RCS scores alone.

Full pathway enrichment analysis results for all patients in the AMD dataset. We list the Entrez gene IDs of up to the top three leading edge genes in the right-most column.
We correlated the two UMAP dimensions with the top 30 genes ranked by their RCS scores. We plot genes with the highest correlation to the first and second UMAP dimensions in Supplementary Figures 5 (b) and 5 (c), respectively. Many genes correlated with the first dimension, but only three genes correlated with the second at an FDR threshold of 5%.

Additional UMAP embedding results for AMD. (a) The UMAP dimensions did not correlate with AMD severity as assessed by the MGS score. Many genes correlated with the first UMAP dimension in (b), but only three genes correlated with the second UMAP dimension in (c). Blue bars passed an FDR threshold of 5%, and error bars denote 95% confidence intervals.
We finally performed drug enrichment analysis in each of the four clusters in Figure 3 (g). We summarize the results in Supplementary Figure 6. Only two drugs – and one potentially therapeutic option – passed FDR correction in patients in the black cluster with the most identified root causal genes according to the RCS scores. In contrast, enrichment analysis identified many drugs in patients in the green cluster with the lowest RCS scores and thus relatively few root causal genes. The pink and blue clusters yielded moderate results. We conclude that drug enrichment analysis expectedly identified more drugs for patients on the left hand side of the UMAP embedding with fewer root causal genes than on the right hand side with many simultaneous root causal genes.

Drug enrichment analysis results by cluster in Figure 3 (g). The analyses recovered similar drugs across clusters, but the results for the green cluster in (c) were supra-significant.
Additional Results for Multiple Sclerosis
Algorithm Comparisons
We compared the algorithms using the MS data with the same criteria used for the AMD dataset. We summarize the results in Supplementary Figure 7 plotted on the next page. Only the histogram of RCSP had large probability mass centered around zero as shown in the first column. The histogram of LiNGAM contained many outliers, so it appears to spike around a value of 18. The histograms of ANM and CausalCell were again near identical. We conclude that only the histogram of RCSP supported an omnigenic root causal model in MS.
We performed pathway enrichment analysis on the algorithm outputs and summarize the results in the second column of Supplementary Figure 7. The functional causal models ANM, LiNGAM and CausalCell did not identify significant pathways at an FDR corrected threshold of 0.05. In contrast, multivariate and univariate regression both identified many significant pathways in blue with no specific link to the blood brain barrier. The top six significant pathways for multivariate and univariate regression involved 112 to 831 and 18 to 545 leading edge genes, respectively. In contrast, the two significant pathways of RCSP involved only 2 and 9 leading genes. We conclude that RCSP detected pathogenic pathways of MS with the sparsest set of leading edge genes.
We finally clustered the algorithm outputs into patient subgroups. We list the sum of squares plots in the third column of Supplementary Figure 7. Univariate regression did not differentiate between the patients because it detected one dominating cluster. RCSP and multivariate regression identified clear subgroups according to the elbow method, whereas the sum of squares plots for ANM, LiNGAM and CausalCell showed no clear cutoffs. We conclude that only RCSP and multivariate regression identified clear patient subgroups in MS.
In summary, only RCSP simultaneously detected an omnigenic root causal model, identified pathogenic pathways with high specificity and discovered clear patient subgroups. We therefore conclude that RCSP also outperformed all other algorithms in the MS dataset.

Comparison of the algorithms in multiple sclerosis.
Biological Results
We provide the full global pathway enrichment analysis results for MS in Supplementary Table 2. Pathway enrichment analysis of the individual clusters in Figure 4 (f) consistently implicated EPH-ephrin signaling among the top two pathways. However, each cluster also involved one separate additional pathway. The green cluster involved the same APC-AXIN pathway as the global analysis via beta-catenin. On the other hand, the blue cluster involved “platelet sensitization by LDL.” Low density lipoprotein enhances platelet aggregation. Platelet degranulation in turn drives the generation of autoreactive T cells in the peripheral circulation during disturbance of the blood brain barrier (Orian et al., 2021). Finally, CTLA4 regulates T-cell homeostasis and inhibits autommunity for the pink cluster (Basile et al., 2022). The D-RCS scores of each cluster thus implicate different mechanisms of T cell pathology.

Full pathway enrichment analysis results for all patients in the MS dataset. We again list up to the top three leading edge genes in the right-most column.

Pathway enrichment analysis results by cluster consistently revealed EPH-ephrin signaling as well as an additional pathway implicating T cell pathology.
The severity of MS, as assessed by the Expanded Disability Status Scale (EDSS) score, did not correlate with either dimension of the UMAP embedding (Supplementary Figure 9 (a)). The top genes in Figure 4 (d) such as MNT and CERCAM also did not correlate. However, lower ranked genes such as TRIP10 did (Supplementary Figure 9 (b)). An expanded correlation analysis with the top 30 genes revealed significant correlations across a variety of lower ranked genes (Supplementary Figures 9 (c) and 9 (d)). We conclude that the distribution of lower ranked genes govern the structure of the UMAP embedding in Figure 4 (f).

Additional analyses of the UMAP embedding for MS. (a) The UMAP dimensions did not correlate with MS severity as assessed by EDSS. However, lower ranked genes such as TRIP10 correlated with both dimensions in (b). We expanded the analysis to the top 30 genes and plot the genes with the highest correlations to UMAP dimension one and two in (c) and (d), respectively.
Proofs
Lemma 1.
Assume Lipschitz continuity of the conditional expectation for all N ≥n0 :

where 

Proof. We can write the following sequence:

where we have applied Expression (6) at the first inequality. We have CN ≤ C for all N ≥ n0 in the second inequality because CN ∈ O(1). With the above bound, choose a > 0 and invoke the Markov inequality:

The conclusion follows because we chose a arbitrarily.
Proposition 1.
If 

Proof. If 

Proposition 2.
We have 
Proof. We can write:

The second equality follows because 

Theorem 2.
(Fisher consistency) Consider the same assumption as Lemma 1. If unconditional d-separation faithfulness holds, then RCSP recovers Φ almost surely as N → ∞.
Proof. If 








References
- A multiplexed single-cell CRISPR screening platform enables systematic dissection of the unfolded protein responseCell 167:1867–1882Google Scholar
- Interplay between ER stress and autophagy: a possible mechanism in multiple sclerosis pathologyExperimental and Molecular Pathology 108:183–190Google Scholar
- The role of inflammation and infection in age-related macular degenerationInternational ophthalmology clinics 47:185–197Google Scholar
- The role of cytotoxic T-lymphocyte antigen 4 in the pathogenesis of multiple sclerosisGenes 13:1319Google Scholar
- mTORC1 activation requires DRAM-1 by facilitating lysosomal amino acid efluxMolecular Cell 76:163–176Google Scholar
- Foundations of structural causal models with cycles and latent variablesThe Annals of Statistics 49:2885–2915Google Scholar
- An expanded view of complex traits: from polygenic to omnigenicCell 169:1177–1186Google Scholar
- Interferon-γ regulates cathepsin G activity in microglia-derived lysosomes and controls the proteolytic processing of myelin basic protein in vitroImmunology 121:82–93Google Scholar
- From GWAS to function: using functional genomics to identify the mechanisms underlying complex diseasesFrontiers in Genetics 11:424Google Scholar
- Comparison and evaluation of statistical error models for scRNA-seqGenome Biology 23:27Google Scholar
- Order-independent constraint-based causal structure learningJournal of Machine Learning Research 15:3741–3782Google Scholar
- RNA-Seq differential expression analysis: An extended review and a software toolPloS One 12:e0190152Google Scholar
- Busulfan treatment for myeloproliferative disease may reduce injection burden in vascular endothelial growth factor-driven retinopathyAmerican Journal of Ophthalmology Case Reports 26:101554Google Scholar
- Pooled CRISPR screening with single-cell transcriptome readoutNature methods 14:297–301Google Scholar
- Perturb-Seq: dissecting molecular circuits with scalable single-cell RNA profiling of pooled genetic screensCell 167:1853–1866Google Scholar
- Reactome pathway analysis: a high-performance in-memory approachBMC Bioinformatics 18:1–9Google Scholar
- XV.—The correlation between relatives on the supposition of Mendelian inheritanceEarth and Environmental Science Transactions of the Royal Society of Edinburgh 52:399–433Google Scholar
- T cells in multiple sclerosis and experimental autoimmune encephalomyelitisClinical & Experimental Immunology 162:1–11Google Scholar
- Multivariate adaptive regression splinesThe Annals of Statistics 19:1–67Google Scholar
- MYC in regulating immunity: metabolism and beyondGenes 8:88Google Scholar
- MTOR-initiated metabolic switch and degeneration in the retinal pigment epitheliumFASEB Journal 34:12502Google Scholar
- Increased expression of ephrins on immune cells of patients with relapsing remitting multiple sclerosis affects oligodendrocyte differentiationInternational Journal of Molecular Sciences 22:2182Google Scholar
- scPerturb: Information Resource for Harmonized Single-Cell Perturbation DataIn: NeurIPS 2022 Workshop on Learning Meaningful Representations of Life Google Scholar
- Validation of noise models for single-cell transcriptomicsNature Methods 11:637–640Google Scholar
- Age-related macular degeneration revisited: From pathology and cellular stress to potential therapiesFrontiers in Cell and Developmental Biology 8:612812Google Scholar
- Cathepsins and their endogenous inhibitors cystatins: expression and modulation in multiple sclerosisJournal of Cellular and Molecular Medicine 15:2421–2429Google Scholar
- Genistein blunts the negative effect of ischaemia to the retina caused by an elevation of intraocular pressureOphthalmic Research 45:65–72Google Scholar
- Cell type-specific transcriptomics identifies neddylation as a novel therapeutic target in multiple sclerosisBrain 144:450–461Google Scholar
- Genistein attenuates choroidal neovascularizationThe Journal of Nutritional Biochemistry 25:1177–1182Google Scholar
- Herp, a new ubiquitin-like membrane protein induced by endoplasmic reticulum stressJournal of Biological Chemistry 275:32846–32853Google Scholar
- Endothelial Wnt/γ-catenin signaling reduces immune cell inflltration in multiple sclerosisProceedings of the National Academy of Sciences 114:E1168–E1177Google Scholar
- EphrinB1 and EphrinB2 regulate T cell chemotaxis and migration in experimental autoimmune encephalomyelitis and multiple sclerosisNeurobiology of Disease 91:292–306Google Scholar
- A compendium of mutational cancer driver genesNature Reviews Cancer 20:555–572Google Scholar
- Targeting SLC1A5 and SLC3A2/SLC7A5 as a potential strategy to strengthen anti-tumor immunity in the tumor microenvironmentFrontiers in immunology 12:624324Google Scholar
- Gaucher diseaseJournal of Clinical and Experimental Hepatology 4:37–50Google Scholar
- A clinical metabolite of azidothymidine inhibits experimental choroidal neovascularization and retinal pigmented epithelium degenerationInvestigative ophthalmology & visual science 61:4–4Google Scholar
- Bidirectional transport of amino acids regulates mTOR and autophagyCell 136:521–534Google Scholar
- The Minnesota Grading System of eye bank eyes for age-related macular degenerationInvestigative Ophthalmology and Visual Science 45:4484–4490Google Scholar
- Platelets in multiple sclerosis: early and central mediators of inflammation and neurodegeneration and attractive targets for molecular imaging and site-directed therapyFrontiers in Immunology 12:620963Google Scholar
- Probability, Random Variables and Stochastic ProcessesGoogle Scholar
- CausalityCambridge University Press Google Scholar
- Causal discovery with continuous additive noise modelsJournal of Machine Learning Research Google Scholar
- Retinal transcriptome and eQTL analyses identify genes associated with age-related macular degenerationNature Genetics 51:606–610Google Scholar
- Mapping information-rich genotype-phenotype landscapes with genome-scale Perturb-seqCell 185:2559–2575Google Scholar
- Separating measurement and expression models clarifies confusion in single-cell RNA sequencing analysisNature Genetics 53:770–777Google Scholar
- An algorithm for fast preranked gene set enrichment analysis using cumulative statistic calculationBioRxiv 60012:1–9Google Scholar
- Kernel Methods for Pattern AnalysisCambridge University Press Google Scholar
- Genetic variants at 13q12.12 are associated with high myopia in the Han Chinese populationThe American Journal of Human Genetics 88:805–813Google Scholar
- Ephrin A receptors and ligands in lesions and normal-appearing white matter in multiple sclerosisBrain Pathology 15:35–45Google Scholar
- Structural basis of the Axin–adenomatous polyposis coli interactionThe EMBO journal 19:2270–2279Google Scholar
- Causation, Prediction, and SearchMIT press Google Scholar
- Directed cyclic graphical representations of feedback modelsIn: Proceedings of the Eleventh Conference on Uncertainty in Artificial Intelligence pp. 491–498Google Scholar
- Cerebral cell adhesion molecule: a novel leukocyte adhesion determinant on blood-brain barrier capillary endotheliumThe Journal of Infectious Diseases 181:181–187Google Scholar
- Causal discovery with a mixture of DAGsMachine Learning :1–25Google Scholar
- Counterfactual Formulation of Patient-Specific Root Causes of DiseaseJournal of Biomedical Informatics Google Scholar
- Identifying patient-specific root causes of diseaseIn: Proceedings of the 13th ACM International Conference on Bioinformatics, Computational Biology and Health Informatics pp. 1–10Google Scholar
- Identifying patient-specific root causes with the heteroscedastic noise modelJournal of Computational Science 72:102099Google Scholar
- Root Causal Inference from Single Cell RNA Sequencing with the Negative BinomialIn: Proceedings of the 14th ACM International Conference on Bioinformatics, Computational Biology and Health Informatics BCB ‘23 New York, NY, USA: Association for Computing Machinery Google Scholar
- Sample-specific root causal inference with latent variablesIn: Conference on Causal Learning and Reasoning pp. 895–915Google Scholar
- Mitigating Pathogenesis for Target Discovery and Disease SubtypingmedRxiv :2023–8Google Scholar
- Arsenic trioxide inhibits proliferation of retinal pigment epithelium by downregulating expression of extracellular matrix and p27International Journal of Clinical and Experimental Pathology 13:172Google Scholar
- Perturbation of RNA Polymerase I transcription machinery by ablation of HEATR1 triggers the RPL5/RPL11-MDM2-p53 ribosome biogenesis stress checkpoint pathway in human cellsCell Cycle 17:92–101Google Scholar
- Dictys: dynamic gene regulatory network dissects developmental continuum with single-cell multiomicsNature Methods 20:1368–1378Google Scholar
- Hierarchical grouping to optimize an objective functionJournal of the American Statistical Association :236–244Google Scholar
- Applying causal discovery to single-cell analyses using CausalCellElife 12:e81464Google Scholar
- DSigDB: drug signatures database for gene set analysisBioinformatics 31:3069–3071Google Scholar
Article and author information
Author information
Version history
- Preprint posted:
- Sent for peer review:
- Reviewed Preprint version 1:
- Reviewed Preprint version 2:
- Version of Record published:
Cite all versions
You can cite all versions using the DOI https://doi.org/10.7554/eLife.100949. This DOI represents all versions, and will always resolve to the latest one.
Copyright
© 2024, Eric V Strobl & Eric Gamazon
This article is distributed under the terms of the Creative Commons Attribution License, which permits unrestricted use and redistribution provided that the original author and source are credited.
Metrics
- views
- 1,827
- downloads
- 74
- citations
- 0
Views, downloads and citations are aggregated across all versions of this paper published by eLife.