STAT3-mediated allelic imbalance of novel genetic variant Rs1047643 and B-cell-specific super-enhancer in association with systemic lupus erythematosus

  1. Huntsville
    United States
  2. Irvine
    United States

Abstract

Mapping of allelic imbalance (AI) at heterozygous loci has the potential to establish links between genetic risk for disease and biological function. Leveraging multi-omics data for AI analysis and functional annotation, we discovered a novel functional risk variant rs1047643 at 8p23 in association with systemic lupus erythematosus (SLE). This variant displays dynamic AI of chromatin accessibility and allelic expression on FDFT1 gene in B cells with SLE. We further found a B-cell restricted super-enhancer (SE) that physically contacts with this SNP-residing locus, an interaction that also appears specifically in B cells. Quantitative analysis of chromatin accessibility and DNA methylation profiles further demonstrated that the SE exhibits aberrant activity in B cell development with SLE. Functional studies identified that STAT3, a master factor associated with autoimmune diseases, directly regulates both the AI of risk variant and the activity of SE in cultured B cells. Our study reveals that STAT3-mediated SE activity and cis-regulatory effects of SNP rs1047643 at 8p23 locus are associated with B cell deregulation in SLE.

Introduction

Super-enhancers (SEs) are recently discovered large domains of clustered enhancers 28Parker et al.201344Whyte et al.2013. The extraordinary feature of SEs is the extremely high and broad enrichment of enhancer-related transcription factors (TFs), H3K4me1 and H3K27ac modifications, resulting in high capability to enhance gene expression programs 44Whyte et al.2013. A large quantity of SEs show cell/tissue specificity 40Vahedi et al.2015, thereby they have become principal determinants of cell identity 15Hnisz et al.2013. Nonetheless, disease-associated SEs, in particular those exhibiting aberrant activity in autoimmune diseases, are less characterized.

Signal transducer and activator of transcription 3 (STAT3), as one of seven STAT family members, is activated by phosphorylation at tyrosine 705 (Y705) and/or at serine 727 (S727) 8Decker and Kovarik2000. After import to the nucleus, the phospho-STAT3 (pSTAT3) modulates gene transcription by binding its target sequence 22Levy and Darnell2002. STAT3 has gained broad attention because it plays a key role in a variety of pathophysiological immune responses related to lymphocyte development and differentiation, and in other cellular processes of normal and tumor cells 48Yu et al.2009.

Systemic lupus erythematosus (SLE) is an autoimmune disease that is known to be associated with an array of abnormal immune cell signaling. B-cell hyperactivity in auto-antigen recognition and interaction with T-cells, which ultimately results in multi-organ damage, is central to the pathogenesis of SLE 31Rahman and Isenberg2008. Genetic factors conferring a predisposition to the development of SLE have been widely characterized. Over 100 loci have been implicated in SLE by genome-wide association studies (GWAS) 6Catalina et al.202047Yin et al.2021. Among them, several genes and/or loci are potent as putative drivers of the disease. For example, genetic risk variants at the promoter of BLK at 8p23 locus alter BLK transcription activity and thus contribute to autoreactive B-cell responses 13Guthridge et al.2014. Nonetheless, the GWAS-identified genetic variants together explained approximately 30% of the heritability of SLE 37Sun et al.201627Morris et al.2016, suggesting a requirement of further efforts to explain the missing heritability of SLE. Meanwhile, there is growing evidence that genetic risk factors behave in a context-dependent or cell-specific manner 13Guthridge et al.201412Gallagher and Chen-Plotkin2018. Thus, for SLE and other autoimmune diseases, there is a need to identify the regulatory programs in which these genetic factors impact the immune cell developmental processes.

One approach for tying genetic risk to function in the post-GWAS era 12Gallagher and Chen-Plotkin2018, is a measurement of allelic imbalance (AI) on two alleles at a given heterozygous locus, typically at single-nucleotide polymorphism (SNP). The genes and/or loci with SNPs exhibiting AI could provide a strong foundation for implicating the genetic or epigenetic mechanisms linked to complex traits or diseases 29Pastinen and Hudson200446Yan et al.2002. As a readout of AI, analyses of allele-specific chromatin accessibility and allele-specific RNA expression have accumulated a wealth of interesting findings, including functional cis-regulation 24Li et al.201352Zhang et al.2020, genomic imprinting 30Pollard et al.2008, X-chromosome inactivation or escape 51Zhang et al.2020. Therefore, tracking AI difference in a comparison between diseases and controls may enable to uncover novel functional variants associated with complex diseases. In this study, we describe one such strategy through integrative multi-omics analysis to discover known or novel functional variants associated with SLE, and report on the identification of a novel risk variant rs1047643 and B-cell-specific SE in B cells with SLE. We further demonstrate that the resultant allelic imbalanced variant and SE activity are directly controlled by STAT3, a master TF that plays a critical role in B cell development and highly associates with autoimmune diseases.

Results

Multi-omics data summary

Functional genomics sequencing data sets comprising 279 samples from eleven studies were collected (Supplementary file 1). Of eleven studies, seven are SLE case-control studies with data across three immune cell types including B cells, T cells, and Neutrophils (Supplementary file 2). Also included in the present study were SNP microarray data from a SLE GWAS study (n = 2279).

Identification of SLE-associated variant showing AI at both chromatin and RNA levels

We next designed a two-stage study (Figure 1) to identify putative SLE-associated functional variants. In stage I, also named as the discovery stage, two chromatin accessibility (ATAC-seq) data sets (Accession ID: GSE118253 and GSE71338, Supplementary file 1) comprised 49 samples were analyzed. We focused on those variants displaying difference in AI of chromatin accessibility at heterozygous SNP sites in a comparison between SLE and controls (see Materials and methods in detail). In total, 18,456 (the GSE118253 dataset) and 4319 (the GSE71338 dataset) SNPs were tested. We collected the resulting SNPs with nominal (unadjusted) p < 0.05. From the reciprocal validation between two data sets, three SNPs (rs1047643, rs246367, and rs72642993) were identified to show the significant AI (combined p < 0.01) in B cells from patients with SLE, relative to controls (Figure 2A and Figure 2—figure supplement 1). Based on annotations from the GWAS central 2Beck et al.2020 and HaploReg 42Ward and Kellis2016 databases, we then focused on the rs1047643 because it is the most promising variant. Meanwhile, in B cells at different stages, the allelic preference of chromatin accessibility for SNP rs1047643 is alterable. For example, the T allele exhibits more preferential chromatin accessibility in activated B cells from patients, relative to the C allele. However, the direction is reversed in SLE naive B cells.

Schematic of the study design.

On the basis of the functional genomic data feature, a two-stage study was designed. Summary of data sets is available in Supplementary files 1-2.

library("ggplot2")
library("gridExtra")
dataSNPNonRn <- read.table("Figure 2-Source Data 2.txt", sep = "\t", header=TRUE, col.names=c("id","chr","pos","ratio","group"))

# Leftplot
leftplot <- ggplot(dataSNPNonRn, aes(x = as.factor(group), y = ratio, color = group, fill=group)) + geom_boxplot(size = 0.2, alpha = 0.75)  + ylab("Allelic ratio\nrs1047643 (T vs C)") + xlab("") + theme_bw() + theme(panel.grid = element_blank(), legend.position = "none", axis.line = element_line(colour="black"), text = element_text(size=11)) + ggtitle("Non-rN B cells")

# P-value
#wilcox.test(dataSNP[dataSNP$group %in% "CNTL", 6], dataSNP[dataSNP$group %in% "SLE", 6])

dataSNPRn <- read.table("Figure 2-Source Data 3.txt", sep = "\t", header=TRUE, col.names=c("id","chr","pos","ratio","group"))

# Rightplot
rightplot <- ggplot(dataSNPRn, aes(x = as.factor(group), y = ratio, color = group, fill=group)) + geom_boxplot(size = 0.2, alpha = 0.75) + ylab("Allelic ratio\nrs1047643 (C vs T)") + xlab("") + theme_bw() + theme(panel.grid.minor = element_blank(), legend.position = "none", axis.line = element_line(colour="black"), text = element_text(size=11)) + ggtitle("rN B cells")

grid.arrange(leftplot,rightplot, nrow=1)

dataSNP <- read.table("Figure 2-Source Data 4.txt", sep = "\t", header=TRUE, col.names=c("id","chr","pos","ratio","group"))

ggplot(dataSNP, aes(x = as.factor(group), y = ratio, color = group, fill=group)) + stat_boxplot(alpha = 0.4, outlier.size = -1, coef=1.95) + geom_point(position = position_jitter(width=0.3), alpha = 0.6, size=I(3)) + ylab("Allelic expression ratio\nRef vs Alt alleles") + xlab("") + theme_bw() + theme(panel.grid = element_blank(), legend.position = "none", axis.line = element_line(colour="black"), text = element_text(size=11))

Boxplot showing allelic expression of SNP rs1047643 in both rN and activated B cells in patients with SLE as compared with healthy individuals

Change of allelic chromatin accessibility and expression in B cell subtypes from SLE patients and controls.

(A) Forest plot showing AI of allelic chromatin state of SNP rs1047643 in both resting naive (rN) and activated (Non-rN) B cells in patients of SLE compared with healthy controls. The p-value per study and combined p-value (summary) are calculated based on the linear regression model and Fisher’s method, respectively. The plot in the right panel displays the 95% of confidence interval of beta-value. (C) Boxplot showing allelic expression of SNP rs1047643 in both rN and activated B cells in patients with SLE as compared with healthy individuals. All raw data are available in Figure 2—source data 1.

Source files for presenting results in Figure 2.This zip archive contains all source data used for the quantitative analyses shown in Figure 2.

Change of allelic chromatin accessibility in B cell subtypes from SLE patients and controls.

Forest plots showing AI of allelic chromatin state of SNP rs246367 (A) and rs72642993 (B) in both rN and activated (Non-rN) B cells in patients of SLE compared with healthy controls. The plots in the right panel display the 95% of confidence interval of beta-value.

Expression pattern of FDFT1 and BLK across B cell subtypes in patients with SLE and healthy controls.

The data showing expression profiles for FDFT1 (A) and BLK (B) in B cell subtypes were from a case-control study (Accession ID: GSE118254).

Expression pattern of FDFT1 and BLK across B cell subtypes in patients with SLE and healthy controls.

The data showing expression profiles for FDFT1 (A) and BLK (B) in B cell subtypes were from a case-control study (Accession ID: GSE92387).

Because the rs1047643 is located in the first exon of FDFT1 gene (Figure 3E), it enables us to test the functionality of this variant at the transcriptional level. Analyzing RNA-seq data (Accession ID: GSE118254), we determined the AI of RNA transcripts for the rs1047643 by comparing the AR values (see Materials and methods in detail) between SLE and controls. In line with results shown above, we observed the dynamic AI pattern on the transcriptional level for the rs1047643 (Figure 2B). Meanwhile, this dynamic allelic expression pattern is specific during B cell development with SLE (Figure 2C).

#' @width 28
#' @height 20
dataSorted <- read.table("Figure 3-Source Data 2.txt", sep = "\t", header = TRUE, col.names = c("group","length","EID","Group","Epigenome.Mnemonic","Color"))

ggplot(dataSorted, aes(x= group, y= length/1000, fill=Group)) + labs(x = "Epigenome ID", y = "Enhancer length (kb)") + geom_bar(stat = "identity") + theme_bw() + theme(
   axis.text.x = element_text(size = 7, angle = 90, hjust = 0), legend.position = "top", legend.direction = "horizontal"
)

Association analysis and functional prediction of SNP rs1047643.

(A) Association results for the SNP rs1047643 with SLE risk in single marker analyses. MAF, minor allele frequency; OR, odds ratio; CI, confidence interval. Adjusted p-trend: after adjustment for 12 GWAS index SNPs (shown in E) in a logistic regression model. (B) Haplotype analyses of the two SNPs (SNP1: GWAS indexed SNP rs17807624; SNP2: rs1047643) in relation to SLE risk. Baseline (the reference haplotype) represents the alleles associated with a reduced risk in two SNPs. (C) Barplot showing the genomic length of chromHMM-annotated enhancer state on the super-enhancer region (blue highlighted in 3 C) in 43 epigenomes. (D) Plot shows the eQTL result of SNP rs1047643 in whole blood or B cells from three databases (shown in y-axis). (E) Genomic annotations of the SNP rs1047643. The three tracks show locations of 13 GWAS index SNP, gene annotation and 15-state chromatin segments in CD19+ B cells at 8p23 locus, respectively. Vertical blue and purple lines, represents the location of super-enhancer and SNP rs1047643, respectively. (F) Long-range interaction between a super-enhancer and SNP rs1047643. The two tracks show chromatin interactions from two independent studies using whole-genome Hi-C and capture Hi-C technologies, respectively. Orange curves show the interactions between the super-enhancer and the SNP rs1047643. (G) Heatmaps showing the 3D DNA interactions at 8p23.1 locus in eight cell lines. The rectangle represents interactions between the super-enhancer and the SNP rs1047643. All raw data are available in Figure 3—source data 1.

Source files for presenting results in Figure 3.This zip archive contains all source data used for the quantitative analyses shown in Figure 3.

Chromatin interactions with FDFT1 promoter region (marked in green arrow) on 8p23 locus from CHi-C data with duplicates in two types of normal T cells.

Orange arrow represents the location of super-enhancer identified in this study.

Heatmaps of Long-range chromatin interactions from Hi-C data in 8p23 locus at 10 kb (or 20 kb) resolution in a panel of human tissues (n = 9) from the 3D Genome Browser.

The circles shown on heatmaps are the interaction density between SNP rs1047643 and SE region.

Association with SLE risk in American Hispanic and European populations

Because SNP rs1047643 has not been reported to be associated with the susceptibility of SLE and other autoimmune diseases, we next tested the association using a dataset from an SLE GWAS case-control study. Employing the univariate analysis for SNP rs1047643 in samples from Hispanic populations, we identified an association of the rs1047643 with SLE risk (OR per C effect allele = 0.77, 95% CI 0.54–0.99, p = 0.023 after adjusting for covariates, Figure 3A), albeit not reaching the significance after adjustment for 12 GWAS index SNPs (the top track in Figure 3E, where one SNP rs2736336 is excluded due to its multivariate alleles). We also examined an association in European population (n = 19,468) from 3Bentham et al.2015 study. A similar result was observed for the rs1047643 (OR per C effect allele = 0.91, 95% CI 0.84–0.98, p = 0.02, Supplementary file 3).

An analysis of linkage disequilibrium (LD) with each of 12 GWAS tag SNPs showed that there was no strong LD (r2 <0.1) between SNP rs1047643 and GWAS SNPs in European population (Supplementary file 4). This result indicates that SNP rs1047643 is a potentially SLE GWAS independent functional variant. Of the 12 index SNPs, indeed, one index SNP rs17807624 with the statistical significance with p < 1.5 × 10–3 using the univariate analysis, is the top signal to which the SNP rs1047643 is conditional. Thus, we performed haplotype analyses on these two SNPs (index SNP rs17807624 and rs1047643, Figure 3B). Compared with the reference haplotype, which carries the alleles associated with a reduced risk in two SNPs, haplotype 2, which carries the risk-associated alleles, showed a significant association (p = 0.03).

Functional annotation

An analysis of eQTL data derived from three independent cohorts indicated both proximal ( < 200 kb) and distal ( > 200 kb) regulatory potential for the SNP rs1047643 in normal B or blood cells (Figure 3D). Interestingly, besides correlated with three adjacent genes (FDFT1, CTSB and NEIL2), the rs1047643 is also an eQTL linked with an upstream BLK gene in a distance of ~300 kb, a result that is detected in two independent data sets. An analysis of RNA-seq data from two independent studies (Accession ID: GSE118254 and GSE92387, Supplementary file 1) consistently showed that expression patterns for two representative genes (BLK and FDFT1) are gradually increased in a developmental process from naive to memory B cells, in particular, the double negative memory B cell subset in patients with SLE, the pattern that is not observed in controls (Figure 2—figure supplements 2 and 3).

By searching for enhancers and other regulatory elements across 8p23 locus from a dataset of the 127 epigenomes from Roadmap, we identified a SE with a length of 7 kb in the upstream of BLK gene in CD19+ B cells (Epigenome ID: E032, Figure 3E). An analysis of enhancer elements across the 127 epigenomes showed 43 (33.9%) epigenomes had enhancers at this SE region. Comparative analysis of the enhancer length at this SE region on the 43 epigenomes further showed that this SE is specific in CD19+ B cells (Epigenome ID: E032, Figure 3C).

Analyzing Hi-C data sets from two independent studies in GM12878 cells, we observed a DNA looping between the SNP rs1047643 within FDFT1 and the SE region (Figure 3F). More importantly, in GM12878 B-lymphoblastic cells, this SE region has a wealth of long-range interactions with adjacent genes (e.g., BLK) and functional elements. In contrast, in another seven cells (Figure 3G), as well as in normal T cells (Figure 3—figure supplement 1) and nine selected tissues (Figure 3—figure supplement 2), these interactions are either much weaker or completely absent. These results indicate that the physical interaction between SNP rs1047643 and SE region, and many interactions with this SE, are specific to B-lymphocytes.

Specificity in B cells

We then hypothesized that the SE region may show aberrant activity in B cells from SLE patients. To test this hypothesis, we conducted quantitative analysis on the same ATAT-seq data (Accession ID: GSE118253 and GSE71338) used in stage I (see Materials and methods in detail). Comparison of SE activity in a quantitative manner between SLE patients and controls indicated that the SE activity is gradually increased through B cell development in SLE patients (Figure 4A–B), with a hyper-activity being observed in double negative (DN) B cells in patients, relative to controls (Figure 4B–C). It should be noted that such a pattern is not observed in the background sampling (Figure 4—figure supplement 1). Similarly, the rs1047643-containing promoter activity also shows up-regulation toward B cell development in SLE patients (Figure 4D–E). In a comparison of B cell development on activities of SE and FDFT1 promoter regions in two individuals, the chromatin accessibility on both regions in an individual with SLE is increased during B cell development, but remains relatively unchanged in the healthy individual (Figure 4F–H).

#' @width 28
#' @height 20
data_final <- read.table("Figure 4-Source Data 1.txt", sep = "\t", header = TRUE, col.names = c("pos","tpm","group","gsmid","cell"))

# ECDF plot 1 within each of two groups
plota <- ggplot(data_final, aes(x=tpm, colour=cell)) + geom_step(aes(y=..y..), stat="ecdf", size = 1.1, alpha = 0.75) + xlab("TPM on a super-enhancer") + ylab("Cumulative frequency") + scale_colour_manual(name = "B-cell", values = c("T3" = "black", "aN" = "#CD950C", "SM" = "#912CEE", "DN" = "red")) + xlim(0, 15) + facet_grid(~ group) + theme_bw() + ggtitle("A")

# ECDF plot 1 between two groups
plotc <- ggplot(data_final, aes(x=tpm, colour=group)) + geom_step(aes(y=..y..), stat="ecdf", size = 1.2, alpha = 0.65) + xlab("TPM on a super-enhancer") + ylab("Cumulative frequency") + xlim(0, 15) + scale_colour_manual(name = "Group", values = c("SLE" = "red", "CNTL" = "black")) + facet_grid(~factor(cell, levels =c("T3","aN","SM","DN"))) + theme_bw() + ggtitle("C")

grid.arrange(plota,plotc, nrow=2)

Aberration of super-enhancer and FDFT1 promoter region in B cell subtypes from SLE patients.

(A) Empirical cumulative distribution of TPM values per 50 bp window across the 7 kb SE region in B cell subsets for disease and control groups. (C) Empirical cumulative distribution of TPM values on the SE region (same as shown in A) in a comparison between two groups across four B cell subtypes.

Aberration of super-enhancer and FDFT1 promoter region in B cell subtypes from SLE patients.

(A) Empirical cumulative distribution of TPM values per 50 bp window across the 7 kb SE region in B cell subsets for disease and control groups. (B) Plots showing the TPM values at the third quartile (Q3) across B cell subtypes as a comparison between SLE and controls. (C) Empirical cumulative distribution of TPM values on the SE region (same as shown in A) in a comparison between two groups across four B cell subtypes. (D) Boxplots showing the TPM values per 50 bp window at the FDFT1 promoter region in B cell subtypes for SLE and controls. The black lines and grey areas represent the linear regression results towards the B cell development from T3 to DN stages, and 95% of CI. (E) Plots showing the correlation between super-enhancer and FDFT1 promoter regions based on mean TPM values with respect to B cell subtypes in SLE and controls. (F) Wiggle plot showing the enrichment of open chromatin states at 8p23.1 locus in B cell subtypes for two individuals (a healthy individual at upper panel, and a patient with SLE at lower panel). Purple and green vertical lines represent the locations for super-enhancer and FDFT1 promoter, respectively. Quantitative comparison of chromatin accessibility states in SE (G) and FDFT1 promoter regions (H) with respect to B cell subtypes. All raw data are available in Figure 4—source data 1.

This txt file contains source data used for the quantitative analyses shown in Figure 4.

Genome-wide background analysis of ATAC-seq data.

Left panel: empirical cumulative distribution of TPM values per 50 bp window across randomly selected regions (n = 2,000) in B cell subsets for disease and control groups. Right panel: plots showing the TPM values at the third quartile (Q3) across B cell subtypes as a comparison between SLE and controls.

Aberration of super-enhancer in resting naive B cell subtypes from SLE patients in relation to healthy controls.

(A) Wiggle plot showing the enrichment of open chromatin states at 8p23.1 locus in resting native B cells from eight individuals. Blue and purple vertical lines represent the locations of SE and FDFT1 promoter, respectively. (B–C) Quantitative comparison of chromatin accessibility states in the SE and FDFT1 promoter regions in naive B cells in a comparison between SLE and controls.

Super-enhancer activity in T and neutrophils from SLE patients and controls.

(A–B) Empirical cumulative distribution of TPM values per 50 bp window and enrichment of ATAC-seq reads (TPM value) across the SE region in neutrophil cell subsets from SLE patients and controls. (C–D) Empirical cumulative distribution of TPM values per 50 bp window and enrichment of ATAC-seq reads (TPM value) across the SE region in two T cell subsets from SLE patients. (E) Wiggle plot showing the enrichment of open chromatin states at 8p23.1 locus in neutrophils and T cells. Blue and purple vertical lines represent the locations of SE and FDFT1 promoter, respectively.

We also quantitatively compared open chromatin states of SE and FDFT1 promoter regions in resting naive B cells (Accession ID: GSE71338). Concordant with the results from active B cell subsets, the open chromatin states on both regions are low in non-active B cells from SLE patients, relative to healthy controls (Figure 4—figure supplement 2).

We further conducted quantitative analyses on ATAC-seq data from another two independent studies in two immune cell types, T cells, and neutrophils (Accession ID: GSE139359 and GSE110017, Supplementary file 1). The results showed that there was no marked enrichment of ATAC-seq reads on both the SE and FDFT1 promoter regions in these two immune cell types for both SLE and controls (Figure 4—figure supplement 3). Collectively, these results suggest a B cell specific, rs1047643-interacting SE whose activity is aberrant in SLE B cell development.

Hypomethylation in SLE B cells

We further analyzed DNA methylation in the SE region using RRBS data in B cell development in a comparison between SLE and controls (Accession ID: GSE118255, Supplementary file 1). Our results show that DNA methylation levels on the SE region are gradually decreased in the developmental process from resting native (rN) to memory B cells in patients with SLE (Figure 5A). In contrast, there is no such obvious change of DNA methylation pattern in the control group. In addition, an analysis of DNA methylation levels on the background sampling doesn’t show such a difference between SLE and controls (Figure 5—figure supplement 1), further suggesting that epigenetic change on the SE region is biologically meaningful in B cell development in SLE.

#' @width 28
#' @height 20
dataTrans <- read.table("Figure 5-Source Data 1.txt", sep = "\t", header = TRUE, col.names = c("values","ind","pos","group","cells"))

ggplot(dataTrans, aes(x =factor(cells, levels=c("rN","T3","aN","SM","DN")), y=values * 100, colour = group)) + geom_boxplot(outlier.size = -1, alpha=0.25, size = 0.1) + ylab("CpG methylation level (%)\non SE region") + xlab("B cell types") + geom_smooth(method = "lm", aes(group=group), size = 1.1, alpha=0.45, level = 0.9) + scale_colour_manual(name = "Group", values = c("CNTL" = "black","SLE" = "red")) + theme_bw() + theme(panel.grid.minor = element_blank(), axis.line = element_line(colour="black"), text = element_text(size=12))

Hypomethylation in super-enhancer region in B cell subtypes from SLE patients.

(A) Boxplots showing the CpG methylation levels per 50 bp window in 7 kb SE region in B cell subtypes for SLE and control groups. The black and red lines represent the linear regression results towards the B cell development from rN to DN stages for SLE and controls, respectively.

Hypomethylation in super-enhancer region in B cell subtypes from SLE patients.

(B) Plots showing the correlation between TPM values (y-axis) and DNA methylation levels (x-axis) averaged over each B cell type in SLE and controls. All raw data are available in Figure 5—source data 1.

This txt file contains source data used for the quantitative analyses shown in Figure 5.

DNA methylation comparison across randomly selected regions in B cell subtypes between patients with SLE and controls.

Boxplots showing the CpG methylation levels per 50 bp window in 2000 randomly selected regions in B cell subtypes for SLE and control groups. The black and red lines represent the linear regression results towards the B cell development from rN to DN stages for SLE and controls, respectively.

A correlation analysis also showed a marked negative correlation between open chromatin states (TPM values, also presented in Figure 4E) and DNA methylation levels at the SE region in the SLE group, relative to the healthy controls (Figure 5B). Together, these results reinforce the aberrant activity of SE in developmental process of B-lymphocytes in patients with SLE.

STAT3 binding on both super-enhancer and rs1047643-residing regions

TF-motif enrichment and binding analysis using the ENCODE TF ChIP-seq dataset (v3) predicted that STAT3 may bind to both the SNP rs1047643-containing promoter and SE regions (data not shown). To validate the finding, we designed two pairs of primers (SE5 and SE3, Figure 6A) to determine the STAT3 binding on SE region and its contribution to the SE activity using STAT3, H3K4me1 and H3K27ac ChIP-qPCR assays in GM11997 cells. Under normal culture conditions, we validated that pSTAT3, H3K4me1 and H3K27ac modifications are remarkably enriched on the SE region (Figure 6A, B and D), but not on the negative control region (Figure 6—figure supplement 1) in B-lymphoblastic cells, relative to IgG mock controls. We then conducted both the inhibition and activation of STAT3 DNA-binding activity using two small molecules. In B-lymphoblastic cells challenged with S3I-201, a STAT3 DNA binding inhibitor, both the DNA binding of STAT3 on SE region and the SE activity are significantly reduced (Figure 6A and B), relative to control. In GM11997 cells treated with ML115, a selective activator of STAT3 (41), both the STAT3 DNA-binding capability on SE region and the SE activity are significantly increased (Figure 6D and E), relative to controls. These results together demonstrate that STAT3 directly modulates the SE activity.

Contribution of STAT3 modulates the enhancer activity and SNP-residing locus in cultured GM11997 cells.

(A) ChIP-qPCR for H3K27ac (left lower panel), H3K4me1 (right lower panel) and pSTAT3 (B) at 8p23 super-enhancer region following 40 μM S3I-201 treatment for 24 hr. Upper panel: UCSC genome browser showing the location of two pairs of qPCR primers (SE5 and SE3) on the SE region (yellow). Two tracks shown below are the enrichment of H3K27ac and H3K4me1 across the SE region. (C) Allelic ChIP-qPCR for pSTAT3 binding on rs1047643 (T vs C alleles) following S3I-201 treatment for 24 hr. (D–E) ChIP-qPCR for H3K27ac (D), and pSTAT3 (E) at 8p23 super-enhancer region following 100 nM ML115 treatment for 6 hr. (F) Allelic ChIP-qPCR for pSTAT3 binding on rs1047643 in cells that have been challenged with ML115 for 6 hr as indicated. Note: the fold changes for the rs1047643-associated BLK and FDFT1 genes in response to small molecules compared to vehicle (0.1% DMSO) as control, which was set as one in all cases, are presented. NS, not significance; *, p < 0.05; **, p < 0.01; ***, p < 0.005.

Quality control of ChIP experiments in GM11997 cells.

Plots showing ChIP-qPCR results for H3K27ac (A and D), H3K4me1 (B and E) and pSTAT3 (C and F) at a negative control (NC) region with the treatment of S3I-201 and ML115, respectively.

Genotyping of SNP rs1047643 in GM11997 genomic DNA using allelic qPCR analysis.

Amplification plots are presented for two alleles.

Validation of STAT3-mediated allelic binding in GM11997 cells.

Plots showing ChIP-qPCR results for pSTAT3 at rs1047643 following 1 μM Cucurbitacin I for 24 hr (A) and 50 ng/ml IL-6 treatment for 1 h (B), respectively. NS, not significance; *, p < 0.05.

We next tested whether the STAT3 might also regulate the rs1047643-residing regions. Using allelic qPCR assay, we confirmed that genomic DNA in the GM11997 cells carries a heterozygous variant for the SNP rs1047643 (Figure 6—figure supplement 2), enabling the AI analysis in this cell model. In GM11997 cells treated with the STAT3 inhibitor S3I-201, STAT3 binding on the risk allele T is significantly reduced, relative to the rs1049643-C allele (Figure 6C). Conversely, we observed an increase of STAT3 DNA binding at the rs1049643-T allele in cells stimulated with the STAT3 activator ML115 (Figure 6F). We further confirmed the findings in cells treated with Cucurbitacin I or IL-6 that acts an inhibitor and stimulator (Figure 6—figure supplement 3) of the Janus Kinase (JAK)/STAT3 signaling pathway 4Blaskovich et al.200317Hunter and Jones2015, respectively.

Consistent with findings in the STAT3 DNA-binding study, we observed a significant change of the rs1049643-T allele at the transcriptional level after treatment with S3I-201 and ML115 at different concentrations and duration times, relative to the C allele (Figure 7A and C and Figure 7—figure supplement 1). These results suggest that the risk rs1049643-T allele is preferentially bound and regulated by STAT3 in B cells.

Expression of two alleles on SNP rs1047643 and its linked genes in cultured cells.

Left panel: allelic RT-qPCR on SNP rs1047643 (T vs C alleles) following S3I-201 (A) and ML115 (C) treatment for 24 hr, respectively. Right panel: RT-qPCR analysis showing the fold changes for the rs1047643-associated BLK and FDFT1 genes in response to different concentrations of S3I-201 (B) and ML115 (D) compared to vehicle (0.1% DMSO) as control, which was set as one in all cases, are presented. *, p < 0.05; **, p < 0.01; ***, p < 0.005.

Expression of two alleles on SNP rs1047643 in B-lymphoblastic cells.

Allelic RT-qPCR in GM11997 cells that have been challenged with S3I-201 for 24 hr (A) and ML115 for 6 hr (B) as indicated, respectively.

Finally, we determined RNA expression of BLK and FDFT1, two representative genes that correlate with the risk rs1047643. The expression levels of both genes are decreased with the treatment of S3I-201 (Figure 7B), and upregulated with the STAT3 activator ML115 (Figure 7D). Together, these results suggest the STAT3-binding risk allele T is associated with increased expression of BLK and FDFT1.

Discussion

In the present study, by integrating a variety of functional genomic data, we performed AI analysis to uncover novel functional promising variants and their regulatory targets in association with SLE. Of note, the diversity of genomic data types from this comprehensive data collection for autoimmune diseases allowed us to develop an approach not used before for accessing the role of variants in SLE disease activity.

One of the most significant findings is the identification of a novel risk variant rs1047643. The association study shows that the rs1049643-T is a risk allele for SLE. Our AI analyses indicate that the rs1049643-T allele resides in more open chromatin state and has higher expression in SLE memory B cell subsets, relative to the C allele. Functional study further provides evidence that the rs1049643-T allele is preferentially bound by STAT3. The SNP rs1047643 is also an eQTL linked with both proximal and distal genes, including BLK, the gene that plays a critical role in B lymphocyte development 33Saijo et al.2003. These results demonstrate that this novel SLE-associated risk rs1047643 whose functionality is mediated by STAT3, may play a role in allele-specific control of adjacent genes at 8p23 locus in B cells. Despite no report for association with other autoimmune diseases, this SNP has been associated with multiple myeloma 41Van Ness et al.2008 and follicular lymphoma 36Skibola et al.2008, two malignant diseases whose pathogenesis is partially associated with the dysfunction of B cells. Specifically, hyperactive STAT3 has been reported to be associated with poor survival in both diseases 16Huang et al.201318Jung et al.2017. Therefore, our findings may provide a clue for genetic and mechanical studies on those B cell associated diseases.

Another intriguing finding in this study is the identification of an aberrant activity of a SE in lupus B cell subsets, particularly the hyperactivity in memory B cells. In contrast, there is no enhancer activity in other immune cells (T cells and neutrophils analyzed in this study) in patients with SLE. We also demonstrate that the aberrant activity of the SE can be mediated by STAT3. Some studies have consistently reported a critical role of STAT3 in the B cell maturation, differentiation, as well as the autoimmunity 1Avery et al.201010Ding et al.2016. These reports further support the significance of STAT3-mediated SE aberration in B cells with SLE.

Several studies have highlighted the 8p23 locus as a major SLE susceptibility region 9Demirci et al.2017. Our study further expands the significance at this locus. For example, our study and others together suggest that there are a few cis-eQTLs linked with transcriptional levels of BLK 13Guthridge et al.20149Demirci et al.2017. Thus, we speculate that the 8p23 locus may play functional roles in B cell development in both genetic and epigenetic fashions. Besides the SNP rs1047643 discovered in the present study, there are 13 SLE-associated GWAS leading SNPs reported in this locus. Of 13 SNPs, six SNPs (Figure 3E) directly sit in the SE region, suggesting these risk variants may play roles in a genetic interaction way, in spite of the unavailability of AI analysis, due to either low coverage (read depth <8) or homozygosity in most or all samples for the 13 SNPs. Epigenetically, the SLE-associated SE has physical interactions with adjacent genes, including BLK and FDFT1, and the risk rs1047643-residing region. This indicates a potentially complex role of the variant rs1047643 for broad regulation by physically contacting the SE. Thus, our data provide new insights into the molecular mechanisms by merging genetic susceptibility with epigenetic impacts on gene expression for autoimmune diseases.

The FDFT1 is a gene encoding for squalene synthase, the enzyme that catalyzes the early step in the cholesterol biosynthetic pathway 39Tozawa et al.1999. Previous studies have shown dyslipidemia, with elevations in total cholesterol, low-density lipoprotein, triglyceride levels in patients with lupus 38Tisseverasinghe et al.2006, especially in the active disease. Our multi-omics data indicate that the SNP rs1047643-linked FDFT1 may be aberrantly activated in B cell development in SLE patients, thereby providing an insight into the genetic implication of lipid metabolism for autoimmune diseases.

The limitations of this study include, due to the presence of six SLE GWAS tagging SNPs in SE region, we are unclear how they genetically influence the SE activity during B cell development. Second, it remains unclear how the AI pattern occurs in naive B cells with lupus. The C allele shows more open chromatin state in SLE naive B cells, this can’t be explained by STAT3 allelic DNA binding at the T allele. This implies that some other factors may also contribute to this dynamic AI pattern. Third, no functional studies on genetic manipulation at the rs1047643 prevent us draw the further conclusion about whether and how the rs1047643 impact the STAT3 binding in the present study.

In addition, it should be noted is the implementation of linear regression model in the initial step to identify the allelic difference signals between SLE and controls. Due to small sample size, there is no statistical power to analyze with more optimal statistical models, such as the logistic regression model. Meanwhile, the unavailability of other variables in regression analysis further restricts this study to remove the potential confounding factors. Together, our analysis may miss some potential AI signals and disable to evaluate the causation.

In conclusion, we identified a novel functional variant and B-cell-specific SE in association with the SLE pathogenesis, both mediated by STAT3, and influencing their gene targets. This insight into the mechanism by which manipulation of STAT3 affects the SE activity and its associated gene expression in B cells may have implications for future drug development in autoimmunity.

Materials and methods

Reagent type (species) or resource Designation Source or reference Identifiers Additional information
Chemical compound, drug ML115 Cayman Chemical Cayman Chemical: 15,178 26Madoux et al.2010
Chemical compound, drug S3I-201 Sigma-Aldrich Sigma-Aldrich: SML0330
Chemical compound, drug Cucurbitacin I Sigma-Aldrich Sigma-Aldrich: C4493
Chemical compound, drug Recombinant human IL-6 Cell Guidance Systems Cell Guidance Systems: GFH10AF
Antibody Phospho-STAT3 (Ser727) Thermo Fisher Scientific Thermo Fisher Scientific Cat# PA5-17876; RRID:AB_10980044
Antibody Anti-Histone H3 (acetyl K27) Abcam Abcam Cat# ab4729; RRID:AB_2118291
Antibody H3K4me1 Recombinant Polyclonal Antibody Thermo Fisher Scientific Thermo Fisher Scientific Cat# 710795; RRID:AB_2532764
Antibody normal mouse IgG Santa Cruz Biotechnology Santa Cruz Biotechnology Cat# sc-2025; RRID:AB_737182
Antibody normal rabbit IgG Santa Cruz Biotechnology Santa Cruz Biotechnology Cat# sc-2027; RRID:AB_737197
Cell line (H. sapiens) GM11997 Coriell Coriell Cat# GM11997; RRID:CVCL_5C55
Sequence-based reagent ChIP-qPCR primers This paper See Supplementary file 5
Sequence-based reagent RT-qPCR primers This paper See Supplementary file 5
Sequence-based reagent Allelic qPCR primers This paper See Supplementary file 5
Software, algorithm R R Foundation https://www.r-project.org Version 4.0.2
Software, algorithm Hisat2 19Kim et al.2019 Version 2
Software, algorithm Allelic imbalance analysis and plots This paper (53Zhang2021) The R code used for the AI analysis can be accessed via github at https://github.com/youngorchuang/Allelic-imbalance-analysis, (copy archived at swh:1:rev:f0db42af8fed130ebbfe0b46abf992300dadddd6)
Software, algorithm HiCUP 45Wingett et al.2015
Commercial assay or kit Mycoplasma detection kit Sigma-Aldrich Sigma-Aldrich:MP0025
Commercial assay or kit SuperScript III reverse transcriptase Thermo Fisher Scientific Thermo Fisher Scientific:18080044
Commercial assay or kit Luna Universal qPCR Master Mix New England Biolabs New England Biolabs:M3003X

Data collection

We collected a variety of functional genomics data, including ATAC-seq, RNA-seq, reduced-representation bisulfite sequencing (RRBS), Hi-C data (Supplementary file 1), from the Gene Expression Omnibus (GEO) and ArrayExpress databases. Meanwhile, we downloaded genotype and Epidemiological data from a SLE case-control study (accession: phs001025.v1) in Hispanic population (1393 cases and 886 controls) from the dbGaP database with approval (accessed 29 Sep 2020).

Analysis of RNA-Seq and ATAC-Seq data

RNA-seq data were analyzed as described previously with few modifications 50Zhang et al.2016. In brief, raw sequencing data were mapped to the human reference genome (hg19) using Hisat2 program 19Kim et al.2019 with the default setting. Aligned data were processed and converted into BAM files using SAMtools program 23Li et al.2009. To quantify gene expression levels, read counts were calculated using the featureCounts (version 2.0.2) program, then implemented in the edgeR package to calculate the count per million (CPM) values.

We used a similar method described previously with several modifications 49Zhang et al.2015 to process the ATAC-seq data. In brief, raw sequencing data were mapped to the human reference genome (hg19) using Bowtie2 program 21Langmead and Salzberg2012 with the default setting. Tag per million (TPM) metric, a method commonly used for read counting normalization, was used to quantitatively present the enrichment of open chromatin states across regions of interest.

Identification of allelic imbalance sites

We used a similar approach described in our previous study to call variants and allelic analysis for both RNA-seq and ATAC-seq data 51Zhang et al.2020. Briefly, the deduplicated reads in BAM format were realigned and recalibrated, and genetic variants were called in a multiple-sample joint manner implemented in the GATK toolkit (version 3.3). We next filtered out variants as follows: 28Parker et al.2013 mapping quality score <20, 44Whyte et al.2013 ≥ 3 SNPs detected within 10 bp distance, 40Vahedi et al.2015 variant confidence/quality by depth <2, 15Hnisz et al.2013 strand bias score >50, 8Decker and Kovarik2000 genotype score <15 and 22Levy and Darnell2002 read depth <8. Then, we extracted SNPs annotated from dbSNP (Build 150) that were called as heterozygotes for each sample. For a reasonable comparison, those heterozygous SNPs identified at least triple in both case and control samples were retained for further analysis.

For a given heterozygous SNP, we calculated allelic ratio (AR) based on read coverage onto two alleles. For RNA-seq data, the resulting AR values were used to compare the AI difference of RNA transcripts between cases and controls. For ATAC-seq data, by testing for associations between AR of each heterozygous SNP (as response variable) and SLE disease status as categorical variable (case/control comparison, control and case are coded as 0 and 1, respectively) implemented in the regression analysis (see below), we analyzed the AI difference of chromatin accessibility between cases and controls. Then, the p-value and beta coefficient were calculated to estimate the significance of the association, and the differences between cases and controls, respectively.

Genetic association analysis

For genotype data from a SLE case-control study in Hispanic population, all typed SNPs in chromosome eight were extracted for imputation using TOPMed Imputation Server 7Das et al.2016. To test SNP rs1047643 in association with SLE, we used a method described previously for univariate and haplotype analyses 35Shi et al.2016. In brief, the per-allele odds ratio (OR) and 95% confidence interval (CI) for the rs1047643 was estimated for SLE risk using a log-additive logistic model with covariates of five countries of the Hispanic population, sex and five principal components (PCs). We used the haplo.stats package in R for haplotype analyses with five countries of the Hispanic population, sex and five PCs as covariates. For SLE GWAS data in European population from 3Bentham et al.2015 study, we downloaded summary statistical data (Accession ID: GCST003156) from GWAS catalog 5Buniello et al.2019 and extracted statistical results for the SNP rs1047643.

A dataset of GWAS leading SNPs was downloaded from the GWAS Catalog 5Buniello et al.2019. Then we extracted SLE-associated SNPs at 8p23. For each indexed SLE-associated SNP at 8p23, we tested the linkage disequilibrium (LD) score (r2) with query SNP rs1047643 from the data set of the Phase 3 of the 1,000 Genomes Project in European population using LDlink web tool 25Machiela and Chanock2015.

Super-enhancer annotation

We downloaded whole-genome chromatin state segmentation data (core 15-state model) for 127 cell types from the Roadmap project. As 28Parker et al.2013 defined, we consider contiguous genomic region marked by states 6–7 (enhancer states, annotated by chromHMM) with ≥3 kb as SE in a cell type. Then, we extracted and annotated super-enhancers on 8p23 locus.

Analysis of eQTL data

We collected eQTL data sets from three large-scale studies, the Genotype-Tissue Expression (GTEx, v8) 20Laboratory2017, the Haploreg v4.1 dataset 42Ward and Kellis2016 and the study by 43Westra2013. By searching for the SNP rsID or the coordinate, we extracted the linked genes with query SNPs and plotted the results based on the significance and studies.

Hi-C data analysis

For in situ Hi-C dataset (Accession ID: GSE63525), we downloaded the Hi-C binary file from Rao et al. study 32Rao et al.2014 and extracted the observed long-range interactions normalized with Knight-Ruiz matrix balancing (KR) method at 10 kb resolution across the 8p23.1 region (the coordinate: chr8:11260000–11740000, hg19).

For other genome-wide Hi-C (Accession ID: GSE113405) and capture Hi-C (CHi-C) datasets (Accession ID: GSE81503 and E-MTAB-6621), we used the Hi-C Pipeline (HiCUP) 45Wingett et al.2015 to truncate and align reads to the human reference genome. The deduplicated data were then processed using the Homer pipeline 14Heinz et al.2010 to call the significant chromatin interaction at 10 kb resolution with the support of ≥5 reads and p ≤ 0.001. The resulting interactions were visualized using UCSC Genome Browser or Sushi package in R environment.

DNA methylation analysis

We downloaded the processed RRBS dataset of DNA methylation profiles on each CpG site from 34Scharer et al.2019 report, then extracted and compared CpG methylation levels on a region of interest between SLE and healthy controls.

Cell culture

GM11997 B lymphoblastic (purchased from Coriell Institute) cells were cultured in RPMI-1640 medium, supplemented with 10% FBS (Thermo Fisher Scientific), 2 mM L-glutamine and 1% penicillin-streptomycin at 37 °C with 5% CO2. These cells are mycoplasma-negative when tested with PCR-based mycoplasma detection kit. For perturbation of STAT3, B cells were plated in 12-well plates or 10 cm dishes one day prior to the experiment. Cells were then treated with S3I-201, ML115, Cucurbitacin I or IL-6. Cells were harvested, washed with PBS and analyzed for proper assays.

Reverse transcription qPCR

Total RNA was isolated from cells using TRIzol Reagent (Invitrogen) according to the manufacturer’s protocol. Oneμg of total RNA was reverse transcribed using SuperScript III reverse transcriptase and random hexamer. One-tenth of the RT reaction was used as a template for real-time PCR using Luna Universal qPCR Master Mix (New England Biolabs) on a QuantStudi six system. Relative expression was calculated with 2−ΔΔCt using the average value of housekeeping gene GAPDH.

Chromatin immunoprecipitation

ChIP was performed as described previously 44Whyte et al.2013. Approximately 10 × 106 suspension cells were harvested and in 10 ml PBS with 1% formaldehyde for 10 min at room temperature, followed by adding 0.125 M glycine for 5 min. Cells were washed and pelleted by centrifugation and lysed with buffer (50 mM Tris-HCl, pH 7.5, 1% IGEPAL CA-630, 1 mM EDTA, 0.1% SDS, plus 1 mM PMSF) in the presence of protease inhibitors and incubated on ice for 30 min. Cell lysate was sonicated to shear DNA to a length of 200–600 bp. The lysates were centrifuged, and supernatant transferred to new tubes. For immunoprecipitation, approximately 2 × 106 cells and 2–3 μg of antibodies or isotype matched IgG as control were used per ChIP and incubated with supernatant at 4 °C on a rotating wheel overnight. Chromatin-antibody complexes were sequentially washed with low-salt buffer, high-salt buffer, LiCl buffer, and TE buffer. Cross-links were reversed by addition of 100 μl of 1% SDS plus 100 mM NaHCO3 and by heating at 65 °C overnight. Following phenol/chloroform/isoamyl alcohol extraction, immunoprecipitated DNA was precipitated with isopropyl alcohol and resuspended in nuclease-free water. For the identification of the specific regions of interest, ~ 10 ng of purified DNA was quantified to determine the percentage of each analyzed region, as well as a negative control region from 11Fullwood et al.2009, against input DNA. The PCR primers are shown in Supplementary file 5.

Additional statistical analysis

Data were presented as mean ± standard deviation (SD) of three replicates unless stated otherwise. Correlation analysis was performed using Pearson’s correlation coefficient. Statistical significance was considered at two-sided P-values less than 0.05.

References

    B cell-intrinsic signaling through IL-21 receptor and STAT3 is required for establishing long-lived antibody responses in humans207The Journal of Experimental Medicine155171
    GWAS Central: a comprehensive resource for the discovery and comparison of genotype and phenotype data from genome-wide association studies48Nucleic Acids Research
    Genetic association analyses implicate aberrant regulation of innate and adaptive immunity genes in the pathogenesis of systemic lupus erythematosus47Nature Genetics14571464
    Discovery of JSI-124 (cucurbitacin I), a selective Janus kinase/signal transducer and activator of transcription 3 signaling pathway inhibitor with potent antitumor activity against human and murine cancer cells in mice63Cancer Research12701279
    The NHGRI-EBI GWAS Catalog of published genome-wide association studies, targeted arrays and summary statistics 201947Nucleic Acids Research
    The pathogenesis of systemic lupus erythematosus: Harnessing big data to understand the molecular basis of lupus110Journal of Autoimmunity
    Next-generation genotype imputation service and methods48Nature Genetics12841287
    Serine phosphorylation of STATs19Oncogene26282637
    Multiple signals at the extended 8p23 locus are associated with susceptibility to systemic lupus erythematosus54Journal of Medical Genetics381389
    STAT3 Signaling in B Cells Is Critical for Germinal Center Maintenance and Contributes to the Pathogenesis of Murine Models of Lupus196Journal of Immunology (Baltimore, Md44774486
    An oestrogen-receptor-alpha-bound human chromatin interactome462Nature5864
    The Post-GWAS Era: From Association to Function102American Journal of Human Genetics717730
    Two functional lupus-associated BLK promoter variants control cell-type- and developmental-stage-specific transcription94American Journal of Human Genetics586598
    Simple combinations of lineage-determining transcription factors prime cis-regulatory elements required for macrophage and B cell identities38Molecular Cell576589
    Super-enhancers in the control of cell identity and disease155Cell934947
    Activation of the STAT3 signaling pathway is associated with poor survival in diffuse large B-cell lymphoma treated with R-CHOP31Journal of Clinical Oncology45204528
    IL-6 as a keystone cytokine in health and disease16Nature Immunology448457
    STAT3 expression is associated with poor survival in non-elderly adult patients with newly diagnosed multiple myeloma52Blood Research293299
    Graph-based genome alignment and genotyping with HISAT2 and HISAT-genotype37Nature Biotechnology907915
    Coordinating Center -Analysis Working G, Statistical Methods groups-Analysis Working Genetic effects on gene expression across human tissues550Nature204213
    Fast gapped-read alignment with Bowtie 29Nature Methods357359
    Stats: transcriptional control and biological impact3Nature Reviews. Molecular Cell Biology651662
    The Sequence Alignment/Map format and SAMtools25Bioinformatics (Oxford, England)20782079
    Integrative eQTL-based analyses reveal the biology of breast cancer risk loci152Cell633641
    LDlink: a web-based application for exploring population-specific haplotype structure and linking correlated alleles of possible functional variants31Bioinformatics (Oxford, England)35553557
    Modulators of STAT Transcription Factors for the Targeted Therapy of Cancer (STAT3 Activators)National Center for Biotechnology Information (US)
    Genome-wide association meta-analysis in Chinese and European individuals identifies ten new loci associated with systemic lupus erythematosus48Nature Genetics940946
    Chromatin stretch enhancer states drive cell-specific gene regulation and harbor human disease risk variants110PNAS1792117926
    Cis-acting regulatory variation in the human genome306Science (New York, N.Y.)647650
    A genome-wide approach to identifying novel-imprinted genes122Human Genetics625634
    Systemic lupus erythematosus358The New England Journal of Medicine929939
    A 3D map of the human genome at kilobase resolution reveals principles of chromatin looping159Cell16651680
    Essential role of Src-family protein tyrosine kinases in NF-kappaB activation during B cell development4Nature Immunology274279
    Epigenetic programming underpins B cell dysfunction in human SLE20Nature Immunology10711082
    Fine-scale mapping of 8q24 locus identifies multiple independent risk variants for breast cancer139International Journal of Cancer13031317
    Polymorphisms in the estrogen receptor 1 and vitamin C and matrix metalloproteinase gene families are associated with susceptibility to lymphoma3PLOS ONE
    High-density genotyping of immune-related loci identifies new SLE risk variants in individuals with Asian ancestry48Nature Genetics323330
    Association between serum total cholesterol level and renal outcome in systemic lupus erythematosus54Arthritis and Rheumatism22112219
    Embryonic lethality and defective neural tube closure in mice lacking squalene synthase274The Journal of Biological Chemistry3084330848
    Super-enhancers delineate disease-associated regulatory nodes in T cells520Nature558562
    Genomic variation in myeloma: design, content, and initial application of the Bank On A Cure SNP Panel to detect associations with progression-free survival6BMC Medicine
    HaploReg v4: systematic mining of putative causal variants, cell types, regulators and target genes for human complex traits and disease44Nucleic Acids Research
    Systematic identification of trans eQTLs as putative drivers of known disease associations45Nature Genetics12381243
    Master transcription factors and mediator establish super-enhancers at key cell identity genes153Cell307319
    HiCUP: pipeline for mapping and processing Hi-C data4F1000Research
    Allelic variation in human gene expression297Science (New York, N.Y.)
    Meta-analysis of 208370 East Asians identifies 113 susceptibility loci for systemic lupus erythematosus80Annals of the Rheumatic Diseases632640
    STATs in cancer inflammation and immunity: a leading role for STAT39Nature Reviews. Cancer798809
    Integrative genomic analysis reveals functional diversification of APOBEC gene family in breast cancer9Human Genomics
    Long intergenic non-coding RNA expression signature in human breast cancer6Scientific Reports
    Skewed allelic expression on X chromosome associated with aberrant expression of XIST on systemic lupus erythematosus lymphocytes29Human Molecular Genetics25232534
    Allele-specific open chromatin in human iPSC neurons elucidates functional disease variants369Science (New York, N.Y.)561565
    https://archive.softwareheritage.org/swh:1:dir:9dec9e4c202c8a7374019f40ad49270021248752;origin=https://github.com/youngorchuang/Allelic-imbalance-analysis;visit=swh:1:snp:47cdfdd9b150ea9a0f0f34eaf59be0e3ab838694;anchor=swh:1:rev:f0db42af8fed130ebbfe0b46abf992300dadddd6