Skip to content

jknightlab/MTOR-Genetics-Project

Repository files navigation

MTOR-Genetics-Project

Zhang, P. et al., Context-specific regulatory genetic variation in MTOR dampens Neutrophil-T cell crosstalk in sepsis, modulating disease. (2025)

Screenshot

Sepsis is a heterogeneous clinical syndrome with a high mortality rate and personalised stratification strategies are proposed as essential to successful targeted therapeutics. Here, we characterise genetic variation that modulates MTOR, a critical regulator of metabolism and immune responses in sepsis. The effects are highly context specific, involving a regulatory element that affects MTOR expression in activated T cells with opposite direction of effect in neutrophils. The lead variant significantly interacts with the known sepsis prognostic marker neutrophil-to-lymphocyte ratio, showing activity specific to sepsis endotype and a pleiotropic effect on type 2 diabetes (T2D) risk. Using ex vivo models, we demonstrate that activated T cells promote immunosuppressive sepsis neutrophils through released cytokines, a process dampened by hypoxia and the mTOR inhibitor rapamycin. The G-allele of the variant, associated with decreased risk of T2D, is associated with reduced mTOR signaling in T cells and improved survival in sepsis patients due to pneumonia. We define a novel epigenetic mechanism that fine-tunes MTOR transcription and T cell activity via the variant-containing regulatory element, which exhibits an allelic effect upon vitamin C treatment. Our findings reveal how common genetic variation can interact with disease state/endotype to modulate immune cell-cell communication, providing a patient stratification strategy to inform more effective treatment of sepsis and suggesting putative mechanisms underlying the variable efficacy of vitamin C therapy in sepsis.

Source of Data:

Table of Contents

1 Identification of context specific eQTLs

1.1 Interaction analysis

eQTL interaction was determined using a linear mixed model as implemented in R package lmerTest: p ~ g + i + g:i + (1|donor), where p is the gene expression corrected for population structure and PEER factors, g is the genotype vector, i is an interaction term for SRS endotypes or log2 transformed NLR, and (1|donor) is a random effect accounting for variability between donors.

# Interaction between MTOR.SNP*SRS or NLR
Rscript ./1.LMM-model-interaction.R <SRS_data_file> <cell_counts_file>
# Inverted eQTLs between Neutrophils and T cells
Rscript ./2.inverted.SRS-interacting.eQTLs.R

1.2 Pairwise linkage disequilibrium (R²) for the MTOR locus

R² was calculated using PLINK with GAinS genotype data (n=1,168) and visualised with LDheatmap.

bash ./3.r2.ld.map.sh

1.3 Colocalisation analysis

Colocalisation analysis was performed in a ±200-bp window surrounding the MTOR lead eQTL, using R package coloc with default settings. eQTL summary statistics from healthy tissue and cell types were retrieved from eQTL Caltalog.

Rscript 4.1.coloc.R && Rscript 4.2.plot.resul.R

2 Survival analysis

To assess the association between genetic variants and 28-day mortality, we use Cox proportional-hazards model and logistic regression adjusting for age, sex, and the first seven genotype principal components.

Rscript ./cox.PH_logistic.regression.R

3 Summary data-based Mendelian randomisation

SMR analysis using eQTLs as instrumental variables to identify genes whose expression is associated with T2D risk due to pleiotropy and/or causality. Genes were included in the analysis if they had at least one cis-eQTL (P < 5e⁻⁸) within a 2 Mbp window around GWAS loci, following the default settings of the SMR tool (v1.3.1). The HEIDI (heterogeneity in dependent instruments) test was applied to differentiate functional associations from linkage effects. LD correlation between SNPs was estimated using 1000 Genomes Project data for Europeans.

# 1 Input file preparation
bash ./1.run.1.sh
"#!/bin/bash
studies=("BLUEPRINT" "Schmiedel_2018" "Schmiedel_2018" "FUSION" "TwinsUK")
sample_groups=("neutrophil" "CD4_T-cell_anti-CD3-CD28" "CD8_T-cell_anti-CD3-CD28" "adipose_naive" "fat")
# Loop through each study and sample group combination
for i in "${!studies[@]}"; do
    study=${studies[$i]}
    sample_group=${sample_groups[$i]}
    echo "Running analysis for $study and $sample_group..."
    # Run the R script with the current study and sample group
    Rscript ./1.smr.file.prep.R "$study" "$sample_group"
done"

# 2 SMR/HEIDI analysis
bash ./2.smr.run.sh

4 Pairwise fixation index (Fst)

Pairwise Fst for the MTOR lead eQTLs (R2>0.95) across 5 superpopulations and 26 subpopulations based on the 1000 Genomes Project data. Fst was calculated using Weir and Cockerham method as implemented in the R package hierfstat.

bash ./Fst.sh

5 RNA-seq analysis

5.1 This section describes the RNA-seq analysis pipeline.

Raw RNA-seq reads were trimmed using Trim Galore (v0.6.2) and aligned to human genome (hg38) using the HISAT2 (v2.1.0). Transcript quantification was performed using featureCounts (v1.6.2) with GENCODE v31 annotations. The bigwig files normalised by RPKM (Reads Per Kilobase per Million mapped reads) were generated using the bamCoverage function of deepTools (version 3.3.1). Differential gene expression analysis was conducted using DESeq2 on raw read counts.

sbatch --wrap="bash 0.get.key.name.sh && bash 1.trimming.sh && bash 2.hisat2.mapping.sh && bash 3.featureCounts.sh && 4.RNASeQC.sh && 5.make.bigwigs.sh"

5.2 PCA & Differential expression analysis

related to Fig.4 & 5

parallel ::: "Rscript ./DEseq2_T.cells_fig.4.R" "Rscript ./DEseq2_T.cells_fig.5.R" "Rscript ./DEseq2-CD4-RNAsesq-Rapamycin-PRJNA532911.R"

5.3 Cell type deconvolution

Cell-type deconvolution was performed with CIBERSORTx using a reference panel derived from a sepsis whole blood scRNA-seq dataset. A signature matrix was built by the Create Signature Matrix analysis module with parameters min. expression = 0.25, replicates = 100 and sampling = 0.5. The CIBERSORTx absolute scores of each cell type in bulk samples were then obtained using the mixture file (Bulk RNAseq count matrix normalised by DESeq2), the signature matrix derived from single cell RNA-seq, the single cell reference matrix for S-mode batch correction and with 100 permutations via the Impute Cell Fractions analysis module.

# association between cell absolute scores and sepsis SRS endotypes
Rscript ./CIBERSORTx_linear.regression_fig.S1.R

5.4 UMAP projection of sepsis whole blood scRNA-seq data

Rscript ./resul-Seurat.R

6 ATAC-seq analysis

This section describes the ATAC-seq analysis pipeline. Sequencing reads for ATAC-seq were aligned to the human genome (hg38) using Bowtie2 (v2.2.5). Data were filtered for quality control using Picard (v2.0.1) and Samtools (v1.9) before peak calling with MACS2 (v2.1.0). Differential peak analysis was performed using DESeq2, considering peaks present in at least 30% of samples. Potential batch effects and/or technical variation were assessed through principal component analysis and incorporated as covariates in the DESeq2 design formula.

6.1 ATAC-seq analysis pipeline

Detailed scripts are publicly available.

# Reads alignment and peak calling 
/ATAC_seq_analysis_slurm_hg38/ATAC_MAIN \
--fastq ./raw.ATACseq/ \
--out ./Results_ATAC \
--min 3 --noidr 8

6.2 PCA & Differential chromatin accessibility analysis

Rscript ./02.ATACseq_DESeq2.R

7 ChIP-seq analysis

This section describes the analysis for hMeDIP-seq. Raw sequencing reads trimmed using Trim Galore (v0.6.2), and aligned to human genome (hg38) using the BWA-mem alignment algorithm (v0.7.12). The binary alignment and map (BAM) files were filtered to remove reads with a mapping quality score less than 10 and duplicate reads using SAMtools (v1.9) and Picard (v2.21.1). The normalised fold enrichment tracks over the corresponding input controls were generated by using the callpeak function with the --SPMR flag, then passing the bedgraph outputs into the bdgcmp function of MACS2 and the bedGraphToBigWig tool.

sbatch --wrap="bash 0.get.key.name.sh && bash 1.trimming.sh && bash 2.BWA.mapping.sh && bash 3.MACS2.peak.call.sh"

8 Single guide RNA (sgRNA) design

We designed and selected top ranked single guide RNA (sgRNA) based on the scoring metrics using FlashFry.

bash ./Create.Database.sh
bash ./Find.Score.gRNAs.sh

Contact

Ping Zhang ([email protected])

About

No description, website, or topics provided.

Resources

Stars

Watchers

Forks

Releases

No releases published

Packages

No packages published