Single-cell transcriptomic atlas of the aged human prefrontal cortex

Overview:

This is a supplementary website for: Single-cell atlas reveals correlates of high cognitive function, dementia, and resilience to Alzheimer’s disease pathology

We generated a single-cell transcriptomic atlas of the aged human prefrontal cortex covering 2.3 million cells from post-mortem human brain samples of 427 ROSMAP study participants with varying degrees of AD pathology and cognitive impairment. We capitalize on ROSMAP’s rich clinical data and detailed post-mortem pathological evaluations to determine cellular and molecular correlates of high cognitive function, dementia, and resilience to AD pathology.

snRNA-seq profiling overview
Cohort overview: We profiled 2.3 million cells from post-mortem human brain samples of 427 ROSMAP study participants with varying degrees of AD pathology and cognitive impairment. Participants were evenly split across the ROS/MAP cohorts, sex, pathologic diagnosis of AD, and covered a range of pathologically and cognitively diagnosed states along AD progression.

In addition to resources provided below and on Synapse, the single-cell transcriptomic dataset is available for interactive visualization through the UCSC Cell Browser.

Contact: Hansruedi Mathys (mathysh at pitt.edu), Zhuyu Peng (pzyverna at mit.edu), and Carles Boix (cboix at mit.edu)

Other studies

Multiple studies from our group have incorporated this resource into their investigation of different aspects of Alzheimer’s disease and may be of interest:

Datasets

Complete human raw data are released in collaboration with ROSMAP through Synapse (syn52293417). The data and human metadata must be accessed through Synapse with a Data Use Certificate (DUC). Human metadata can be found at Synapse (syn3157322) or can be requested through the RADC Hub.

Datasets corresponding to manuscript analyses can be found here and are summarized in the table below. Processed human datasets have been deidentified to protect confidentiality - the mapping to ROSMAP IDs and complete metadata can be found on Synapse.

Dataset Files/Locations Description  
Individual metadata tsv Metadata table for all 427 ROSMAP study participants  
Cell types csv Table listing all major and high-resolution cell types  
Inhibitory classes xlsx Inhibitory neuron subclass assignment used in this study  
Joint data (raw) h5ad Joint expression matrix/dataset for the full set of cell types in the atlas
Batch mapping tsv Mapping between batch & run number and ROSMAP subject identifier  
Cell type-specific data directory Processed RDS files for each major cell type group in the atlas, described below  
SI - DEGs directory Supplementary information: differential gene expression analyses  
SI - Gene overlap directory Supplementary information: gene overlap between cognition and pathology analyses  

Processed count matrices

We provide gene-count matrices for seven major cell classes including:

The excitatory neurons were split into three subsets. The subsets contain the following excitatory neuron subtypes:

  • Set1: Exc L2-3 CBLN2 LINC02306
  • Set2: Exc L3-4 RORB CUX2, Exc L3-5 RORB PLCH1, Exc L4-5 RORB IL1RAPL2, Exc L4-5 RORB GABRG1
  • Set3: Exc L5-6 RORB LINC02196, Exc L6 THEMIS NFIA, Exc L5/6 IT Car3, Exc L5 ET, Exc L5/6 NP, Exc L6 CT, Exc L6b, Exc RELN CHD7, Exc NRGN

Loading the processed data

The Seurat objects can be loaded in R as follows:

library(Seurat)
setwd("/path/to/the/folder/containing/the/data")
object = readRDS("Excitatory_neurons_set1.rds")

# Metadata annotation for each cell stored in the Seurat object:
# - subject: a unique (deidentified) identifier of the ROSMAP study participant the cell was isolated from 
# - cell_type_high_resolution: high-resolution cell type assignment for each individual cell
object@meta.data[["subject"]]
object@meta.data[["cell_type_high_resolution"]]

Loading the raw data

The unfiltered gene-count matrix AnnData file (PFC427_raw_data.h5ad) can be loaded using scanpy in python:

import scanpy as sc
adata = sc.read_h5ad("/path/to/PFC427_raw_data.h5ad")