Linear/Logistic Regression

Test: T043

Date: 4/9/2024

Link Github: https:/github.com/RushAlz/Cytokines/tree/main/sn_RNAseq_DLPFC/T043

Objective: Filter to show only significant results from the linear and/or logistic regressions from single-nuclei data (T019)

Read data and prepare inputs

library(limma)
library(edgeR)

norm_method = "none"

# Define the covariates for the model
covs <- c("batch","pmi")

for(cell_i in names(celltype_exp)) {
  exprData = celltype_exp[[cell_i]]
  exprData.meta = pheno_SN[match(colnames(exprData), pheno_SN$projid), ]
  
  # Construct the design matrix from covariates
  design_formula <- paste0("~", paste0(covs, collapse = "+")) %>% as.formula()
  design <- model.matrix(design_formula, data = exprData.meta)
  design <- design[, colSums(design) > 0] # Remove columns with zero sum

  # Normalize counts and fit linear model using voom and lmFit
  fit <- lmFit(exprData, design) 
  
  # Adjust data based on fitted model, excluding the intercept
  indx <- grepl("(Intercept)", colnames(fit$design))
  adjusted_data <- exprData - (fit$design[, !indx] %*% t(fit$coefficients[, !indx]))
  celltype_exp[[cell_i]] = adjusted_data
}
library(sva)
for(cell_i in names(celltype_exp)) {
  exprData = celltype_exp[[cell_i]]
  exprData.meta = pheno_SN[match(colnames(exprData), pheno_SN$projid), ]
  
  adjusted_data <- ComBat(exprData, exprData.meta$batch)
  celltype_exp[[cell_i]] = adjusted_data
}
saveRDS(celltype_exp, file.path(work_dir, "snRNA_pseudoBulk_7majCellTypes.ComBat.rds"))

Prepare parameters

celltype_exp <- readRDS(file.path(work_dir, "snRNA_pseudoBulk_7majCellTypes.ComBat.rds"))
load("/pastel/resources/data2share/bulk_MF/bulk_DLPFC_2022.Rdata")

celltype_exp[["bulk DLPFC"]] = exprData_DLPFC

covariates = c("age_death","msex", "educ", "pmi")

pheno_list = c(
  "cogng_demog_slope"="gaussian",
  "cogng_path_slope"="gaussian",
  "tangles_sqrt"="gaussian",
  "amyloid_sqrt"="gaussian",
  "gpath"="gaussian",
  "ad_dementia_status"="binomial",
  "cog_impairment_status"="binomial"
)

Run association tests

assoc_results = list()
for(cell_i in names(celltype_exp)) {
  exprData = as.data.frame(celltype_exp[[cell_i]])
  
  # Filter the gene expression
  exprData_ensembl = gsub("(.*)\\.(.*)","\\1", rownames(exprData)) 
  exprData_filt = exprData[exprData_ensembl %in% cytokines$ensembl, ]
  exprData_filt$ensembl = gsub("(.*)\\.(.*)","\\1",rownames(exprData_filt))
  exprData_cytokines = merge(exprData_filt, cytokines, by = "ensembl")
  rownames(exprData_cytokines) = exprData_cytokines$symbol
  exprData_cytokines$ensembl = NULL
  exprData_cytokines$symbol = NULL
  
  data4linear_reg <- as.data.frame(t(exprData_cytokines))
  phenotype_dt <- pheno_SN[match(rownames(data4linear_reg), pheno_SN$projid), ]

  res_test = run_module_trait_association(data4linear_reg, 
                                          phenotype_dt, 
                                          pheno_list,
                                          covariates = covariates)
  
  assoc_results[[cell_i]] = res_test
}
## Loading required package: lme4
## Loading required package: Matrix
## 
## Attaching package: 'Matrix'
## The following objects are masked from 'package:tidyr':
## 
##     expand, pack, unpack
## Loading required package: lmerTest
## 
## Attaching package: 'lmerTest'
## The following object is masked from 'package:lme4':
## 
##     lmer
## The following object is masked from 'package:stats':
## 
##     step
## Loading required package: performance
## Loading required package: ggeffects
## Loading required package: parameters
## Loading required package: datawizard
## 
## Attaching package: 'datawizard'
## The following objects are masked from 'package:ggpubr':
## 
##     mean_sd, median_mad
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ THPO +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF9 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ EGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CCL28 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL16 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL17 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ THPO +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF9 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ EGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CCL28 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL16 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL17 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IGF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF9 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ EGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL16 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ NOG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IGF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF9 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ EGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL16 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ NOG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IFNA2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IFNA13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IFNA2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IFNA13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IFNA2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IFNA13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IFNA2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IFNA13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IFNA2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IFNA13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IGF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF9 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ GDNF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CSF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IFNA2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL17 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IFNA13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IGF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF9 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ GDNF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CSF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IFNA2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL17 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IFNA13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FLT3LG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL33 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ EGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CTF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CSF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL17 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FLT3LG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL33 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ EGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CTF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CSF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL17 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL17) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FLT3LG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ GDNF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CSF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL17 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FLT3LG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ GDNF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CSF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL17 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL1A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL1A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL1A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL1A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL7) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL1A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IGF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FLT3LG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ EBI3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF8 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL1A +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF10 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL1B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL16 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IGF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FLT3LG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL7 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ EBI3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF8 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL1A +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF10 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL1B +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL16 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=404): scale(cogng_demog_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=380): scale(cogng_path_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(tangles_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=422): scale(amyloid_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): scale(gpath) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL32 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF10 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): ad_dementia_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL32 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF10 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=424): cog_impairment_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(CXCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL11) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(CCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(CXCL5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL12A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(CXCL8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1142): scale(cogng_demog_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(CXCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL11) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(CCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(CXCL5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL12A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(CXCL8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1076): scale(cogng_path_slope) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(CXCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL11) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(CCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(CXCL5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL12A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(CXCL8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1201): scale(tangles_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(CXCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL11) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(CCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(CXCL5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL12A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(CXCL8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1203): scale(amyloid_sqrt) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(CX3CL1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL32) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(DCN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IGF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(HGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(KITLG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(CXCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(THPO) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(FLT3LG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL11) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(TNFSF13B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(EBI3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(TGFB1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(C5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(CCL2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(VEGFA) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(TNFSF4) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(SPP1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(TNFSF10) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL1B) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(PSPN) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(TNFSF9) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(C3) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL33) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(FGF2) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(EGF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(CXCL14) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(CTF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL18) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(CCL28) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL34) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(TNFSF13) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(CXCL5) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL15) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(GDNF) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL12A) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(CXCL8) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL16) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(IL17D) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(NOG) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(CSF1) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1210): scale(gpath) ~ scale(TNFSF12) +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL32 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IGF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ CXCL2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ THPO +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ FLT3LG +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL11 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ EBI3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ CCL2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ TNFSF10 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL1B +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ TNFSF9 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL33 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ EGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ CTF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ CCL28 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ CXCL5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ GDNF +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL12A +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ CXCL8 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL16 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ NOG +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ CSF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): ad_dementia_status ~ TNFSF12 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ CX3CL1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL32 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ DCN +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IGF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ HGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ KITLG +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ CXCL2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ THPO +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ FLT3LG +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL11 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ TNFSF13B +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ EBI3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ TGFB1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ C5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ CCL2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ VEGFA +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ TNFSF4 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ SPP1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ TNFSF10 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL1B +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ PSPN +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ TNFSF9 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ C3 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL33 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ FGF2 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ EGF +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ CXCL14 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ CTF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL18 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ CCL28 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL34 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ TNFSF13 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ CXCL5 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL15 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ GDNF +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL12A +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ CXCL8 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL16 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ IL17D +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ NOG +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ CSF1 +  age_death + msex + educ + pmi"
## [1] "Testing (n=1209): cog_impairment_status ~ TNFSF12 +  age_death + msex + educ + pmi"
save(assoc_results, file = file.path(work_dir, "cytokines_snRNA_association_results.RData"))
load(file.path(work_dir, "cytokines_snRNA_association_results.RData"))

bulk DLPFC

createDT(assoc_results$`bulk DLPFC`$all_stats_df)

bulk DLPFC (male only)

createDT(res_test$all_stats_df)

bulk DLPFC (female only)

createDT(res_test$all_stats_df)

Excitatory Neurons

createDT(assoc_results$ext$all_stats_df)

Inhibitory Neurons

createDT(assoc_results$inh$all_stats_df)

Microglia

createDT(assoc_results$mic$all_stats_df)

Oligodendrocytes

createDT(assoc_results$oli$all_stats_df)

Astrocytes

createDT(assoc_results$ast$all_stats_df)

Oligodendrocyte progenitor cells

createDT(assoc_results$opc$all_stats_df)

Endothelial cells

createDT(assoc_results$end$all_stats_df)

IL-15

celltype_exp <- readRDS(file.path(work_dir, "snRNA_pseudoBulk_7majCellTypes.ComBat.rds"))
load("/pastel/resources/data2share/bulk_MF/bulk_DLPFC_2022.Rdata")

celltype_exp[["bulk DLPFC"]] = exprData_DLPFC

dt_res1 = as.data.frame(celltype_exp[["mic"]], check.names = F) 
dt_res1_selected = dt_res1[rownames(dt_res1) %in% cytokines$ensembl, ]
# long format for the plot
dt_res1_selected_l = dt_res1_selected %>% 
  rownames_to_column("ensembl") %>%
  pivot_longer(-ensembl, values_to = "expression", names_to = "projid") %>%
  mutate(celltype = "mic")

dt_res2 = as.data.frame(celltype_exp[["bulk DLPFC"]], check.names = F) 
dt_res2_selected = dt_res2[gsub("(.*?)\\.(.*)","\\1",rownames(dt_res2)) %in% cytokines$ensembl, ]
# long format for the plot
dt_res2_selected_l = dt_res2_selected %>% 
  rownames_to_column("ensembl") %>%
  mutate(ensembl = gsub("(.*?)\\.(.*)","\\1",ensembl)) %>%
  pivot_longer(-ensembl, values_to = "expression", names_to = "projid") %>%
  mutate(celltype = "bulk DLPFC")

# join to get the gene_name
dt_res_selected_l = bind_rows(dt_res1_selected_l,dt_res2_selected_l) %>%
  left_join(cytokines, by = "ensembl")

IL15 expression by diagnosis

# join to get the phenotype 
dt_res_selected_l_meta = dt_res_selected_l %>% 
  left_join(pheno_SN, by = "projid") %>%
  filter(symbol == "IL15")

# By diagnosis 
dt_res_selected_l_meta$cogdx_3grp[dt_res_selected_l_meta$cogdx_3grp == 0] <- "NCI"
dt_res_selected_l_meta$cogdx_3grp[dt_res_selected_l_meta$cogdx_3grp == 1] <- "MCI"
dt_res_selected_l_meta$cogdx_3grp[dt_res_selected_l_meta$cogdx_3grp == 2] <- "AD"

dt_res_selected_l_meta$cogdx_3grp = factor(dt_res_selected_l_meta$cogdx_3grp, levels = c("NCI", "MCI", "AD"))
names(dt_res_selected_l_meta)[names(dt_res_selected_l_meta) == 'cogdx_3grp'] <- 'Diagnosis'

p <- ggplot(na.omit(dt_res_selected_l_meta[, c("Diagnosis", "expression", "symbol", "celltype")]), aes(x = Diagnosis, y = expression, color = Diagnosis)) + 
  geom_boxplot(notch=F, fill="white", color="black", outlier.shape=NA, lwd=0.4, alpha=1, width=.7, fatten = 3) +
  ggbeeswarm::geom_quasirandom(alpha=.8, width=.2, show.legend=F, size=2) + 
  geom_pwc(method = "t_test", label = "p.adj.signif", p.adjust.method = "bonferroni",
           label.y.npc = "top", label.size = 5, hide.ns = TRUE) +
  stat_summary(fun = median, fun.min = median, fun.max = median,
                   geom = "crossbar", width = .7, color = "black") +
  facet_wrap(~celltype, scales = "free_y", nrow = 1, strip.position = "left", 
                labeller = as_labeller(c(`bulk DLPFC` = "IL15 expression in bulk DLPFC", mic = "IL15 expression in microglia") ) ) +
  # facet_wrap(~ celltype+symbol, scales = "free_y") + 
  scale_y_continuous(expand = expansion(mult = c(0, 0.1))) +
  scale_color_manual(values = c("AD" = "#BB5566", "MCI" = "#DDAA33", "NCI" = "#004488")) + 
  xlab("Final consensus diagnosis") + 
  ylab(NULL) +
  labs(title = "IL15 expression by diagnosis") +
  theme_classic() +
  theme(strip.background = element_blank(),
        strip.text = element_text(size = 11),
        strip.placement = "outside",
        legend.position = "none")

# Print the plot
print(p)

# Save to PDF
cairo_pdf(paste0(work_dir,"/boxplot_IL15_by_diag_review1.pdf"), width = 4.5, height = 3.5)
print(p)
dev.off()
## png 
##   2
# Save to PNG
png(paste0(work_dir,"/boxplot_IL15_by_diag_review1.png"), width = 4.5, height = 3.5, res = 600, units = "in")
print(p)
dev.off()
## png 
##   2

IL15 expression by gpath (mic)

# By gpath
p = ggplot(na.omit(dt_res_selected_l_meta[dt_res_selected_l_meta$celltype == "mic",
                                      c("gpath","Diagnosis", "expression", "symbol", "celltype")]), 
       aes(x = expression, y = gpath, color = Diagnosis)) + 
  geom_point(size = 1.5, alpha = 0.6) +
  stat_smooth(method = "lm", se = F) + # Add regression line
  stat_cor(method = "spearman", label.x.npc = "left", label.y.npc = "top", size = 4, show.legend = F) +
  easy_labs(y = "Global AD burden", x = "IL15 expression", title = "IL15 expression on microglia for global AD burden") +
  scale_color_manual(values = c("AD" = "#BB5566", "MCI" = "#DDAA33", "NCI" = "#004488")) + 
  theme_classic()

# Print the plot
print(p)

# Save to PDF
cairo_pdf(paste0(work_dir,"/scatterplot_IL15_by_gpath_mic_review1.pdf"), width = 5, height = 3.5)
print(p)
dev.off()
## png 
##   2
# Save to PNG
png(paste0(work_dir,"/scatterplot_IL15_by_gpath_mic_review1.png"), width = 5, height = 3.5, res = 600, units = "in")
print(p)
dev.off()
## png 
##   2

IL15 expression by cog. decline (bulk)

# By cogng_demog_slope
p = ggplot(na.omit(dt_res_selected_l_meta[dt_res_selected_l_meta$celltype == "bulk DLPFC",
                                      c("cogng_demog_slope","Diagnosis", "expression", "symbol", "celltype")]), 
       aes(x = expression, y = cogng_demog_slope, color = Diagnosis)) + 
  geom_point(size = 1.5, alpha = 0.5) +
  stat_smooth(method = "lm", se = F) + # Add regression line
  stat_cor(method = "spearman", label.x.npc = "left", label.y.npc = 0.2, size = 4, show.legend = F) +
  easy_labs(y = "Cognitive decline (slope)", x = "IL15 expression", title = "IL15 expression on bulk DLPFC for cognitive decline") +
  scale_color_manual(values = c("AD" = "#BB5566", "MCI" = "#DDAA33", "NCI" = "#004488")) + 
  theme_classic()

# Print the plot
print(p)

# Save to PDF
cairo_pdf(paste0(work_dir,"/scatterplot_IL15_by_cogdec_bulk_review1.pdf"), width = 5, height = 3.5)
print(p)
dev.off()
## png 
##   2
# Save to PNG
png(paste0(work_dir,"/scatterplot_IL15_by_cogdec_bulk_review1.png"), width = 5, height = 3.5, res = 600, units = "in")
print(p)
dev.off()
## png 
##   2

Session info

sessionInfo()
## R version 4.1.2 (2021-11-01)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: CentOS Stream 8
## 
## Matrix products: default
## BLAS/LAPACK: /usr/lib64/libopenblasp-r0.3.15.so
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_US.UTF-8        LC_COLLATE=en_US.UTF-8    
##  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
## 
## attached base packages:
## [1] grid      stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] gridExtra_2.3         datawizard_0.13.0     parameters_0.22.1    
##  [4] ggeffects_1.7.2       performance_0.12.2    lmerTest_3.1-3       
##  [7] lme4_1.1-35.1         Matrix_1.6-5          RColorBrewer_1.1-3   
## [10] circlize_0.4.16       ComplexHeatmap_2.15.4 ggsignif_0.6.4       
## [13] ggeasy_0.1.5          ggpubr_0.6.0          lubridate_1.9.3      
## [16] forcats_1.0.0         stringr_1.5.1         purrr_1.0.4          
## [19] tidyr_1.3.1           tibble_3.3.0          tidyverse_2.0.0      
## [22] ggplot2_3.5.1         readr_2.1.5           rstatix_0.7.2        
## [25] dplyr_1.1.4          
## 
## loaded via a namespace (and not attached):
##  [1] ggbeeswarm_0.7.2    TH.data_1.1-2       minqa_1.2.8        
##  [4] colorspace_2.1-1    rjson_0.2.23        estimability_1.5.1 
##  [7] GlobalOptions_0.1.2 clue_0.3-66         rstudioapi_0.17.1  
## [10] farver_2.1.2        DT_0.33             bit64_4.6.0-1      
## [13] mvtnorm_1.3-2       codetools_0.2-18    splines_4.1.2      
## [16] doParallel_1.0.17   cachem_1.1.0        knitr_1.49         
## [19] Formula_1.2-5       jsonlite_2.0.0      nloptr_2.1.1       
## [22] Cairo_1.6-2         broom_1.0.7         cluster_2.1.2      
## [25] png_0.1-8           compiler_4.1.2      emmeans_1.10.5     
## [28] backports_1.5.0     fastmap_1.2.0       cli_3.6.5          
## [31] htmltools_0.5.8.1   tools_4.1.2         coda_0.19-4.1      
## [34] gtable_0.3.6        glue_1.8.0          Rcpp_1.0.14        
## [37] carData_3.0-5       cellranger_1.1.0    jquerylib_0.1.4    
## [40] vctrs_0.6.5         nlme_3.1-153        crosstalk_1.2.1    
## [43] iterators_1.0.14    insight_0.20.5      xfun_0.49          
## [46] timechange_0.3.0    lifecycle_1.0.4     MASS_7.3-60.0.1    
## [49] zoo_1.8-12          scales_1.3.0        vroom_1.6.5        
## [52] hms_1.1.3           parallel_4.1.2      sandwich_3.1-1     
## [55] yaml_2.3.10         sass_0.4.9          stringi_1.8.7      
## [58] bayestestR_0.15.0   S4Vectors_0.32.4    foreach_1.5.2      
## [61] BiocGenerics_0.40.0 boot_1.3-28         shape_1.4.6.1      
## [64] rlang_1.1.6         pkgconfig_2.0.3     matrixStats_1.5.0  
## [67] evaluate_1.0.1      lattice_0.20-45     labeling_0.4.3     
## [70] htmlwidgets_1.6.4   bit_4.6.0           tidyselect_1.2.1   
## [73] magrittr_2.0.3      R6_2.6.1            IRanges_2.28.0     
## [76] magick_2.8.5        generics_0.1.4      multcomp_1.4-26    
## [79] mgcv_1.9-1          pillar_1.10.2       withr_3.0.2        
## [82] survival_3.7-0      abind_1.4-8         crayon_1.5.3       
## [85] car_3.1-3           tzdb_0.4.0          rmarkdown_2.29     
## [88] GetoptLong_1.0.5    readxl_1.4.5        digest_0.6.37      
## [91] xtable_1.8-4        numDeriv_2016.8-1.1 stats4_4.1.2       
## [94] munsell_0.5.1       beeswarm_0.4.0      vipor_0.4.7        
## [97] bslib_0.8.0