All Projects → LieberInstitute → HumanPilot

LieberInstitute / HumanPilot

Licence: other
Spatial Transcriptomics human DLPFC pilot study part of the spatialLIBD project

Programming Languages

HTML
75241 projects

Projects that are alternatives of or similar to HumanPilot

Tidyversity
🎓 Tidy tools for academics
Stars: ✭ 155 (+604.55%)
Mutual labels:  analysis, rstats
Fieldtrip
The MATLAB toolbox for MEG, EEG and iEEG analysis
Stars: ✭ 481 (+2086.36%)
Mutual labels:  analysis, brain
syncopy
Systems Neuroscience Computing in Python: user-friendly analysis of large-scale electrophysiology data
Stars: ✭ 19 (-13.64%)
Mutual labels:  analysis, brain
hnn
The Human Neocortical Neurosolver (HNN) is a software tool that gives researchers/clinicians the ability to develop/test hypotheses on circuit mechanisms underlying EEG/MEG data.
Stars: ✭ 62 (+181.82%)
Mutual labels:  human, brain
epanetReader
Read text files in Epanet's .inp and .rpt formats into R
Stars: ✭ 18 (-18.18%)
Mutual labels:  rstats
SvelteScaling
Does Svelte scale?
Stars: ✭ 21 (-4.55%)
Mutual labels:  analysis
SqlServer.Rules
SQL Server static code analysis rules for SSDT database projects
Stars: ✭ 20 (-9.09%)
Mutual labels:  analysis
mousetrap
Process and Analyze Mouse-Tracking Data
Stars: ✭ 33 (+50%)
Mutual labels:  analysis
neuralBlack
A Multi-Class Brain Tumor Classifier using Convolutional Neural Network with 99% Accuracy achieved by applying the method of Transfer Learning using Python and Pytorch Deep Learning Framework
Stars: ✭ 36 (+63.64%)
Mutual labels:  brain
statically
📸 Generate Webpage Screenshots Using the Statically API
Stars: ✭ 28 (+27.27%)
Mutual labels:  rstats
liground
A free, open-source and modern Chess Variant Analysis GUI for the 21st century
Stars: ✭ 41 (+86.36%)
Mutual labels:  analysis
SpiceMix
spatial transcriptome, single cell
Stars: ✭ 19 (-13.64%)
Mutual labels:  spatial-transcriptomics
cablecuttr
An R wrapper for CanIStream.It API
Stars: ✭ 17 (-22.73%)
Mutual labels:  rstats
fornalder
Visualize long-term trends in collections of Git repositories.
Stars: ✭ 80 (+263.64%)
Mutual labels:  analysis
mikropml
User-Friendly R Package for Supervised Machine Learning Pipelines
Stars: ✭ 34 (+54.55%)
Mutual labels:  rstats
cis
Home of the Community Intercomparison Suite.
Stars: ✭ 30 (+36.36%)
Mutual labels:  analysis
travis
⛔ ARCHIVED ⛔ Set Up 'Travis' for Testing and Deployment
Stars: ✭ 61 (+177.27%)
Mutual labels:  rstats
wdlRunR
Elastic, reproducible, and reusable genomic data science tools from R backed by cloud resources
Stars: ✭ 34 (+54.55%)
Mutual labels:  rstats
RAnalysisSkeleton
Files and settings commonly used in analysis projects with R
Stars: ✭ 15 (-31.82%)
Mutual labels:  analysis
should-i-play-f6
Chess project to analyze the statistical effect of playing f3 (as white) or f6 (as black) on the outcome of the game.
Stars: ✭ 15 (-31.82%)
Mutual labels:  analysis

HumanPilot

DOI

Welcome to the spatialLIBD project! It is composed of the HumanPilot described here as well as:

This web application allows you to browse the LIBD human dorsolateral pre-frontal cortex (DLPFC) spatial transcriptomics data generated with the 10x Genomics Visium platform. Through the R/Bioconductor package you can also download the data as well as visualize your own datasets using this web application. Please check the bioRxiv pre-print for more details about this project.

If you tweet about this website, the data or the R package please use the #spatialLIBD hashtag. You can find previous tweets that way as shown here. Thank you!

Study design

As a quick overview, the data presented here is from portion of the DLPFC that spans six neuronal layers plus white matter (A) for a total of three subjects with two pairs of spatially adjacent replicates (B). Each dissection of DLPFC was designed to span all six layers plus white matter (C). Using this web application you can explore the expression of known genes such as SNAP25 (D, a neuronal gene), MOBP (E, an oligodendrocyte gene), and known layer markers from mouse studies such as PCP4 (F, a known layer 5 marker gene).

This web application was built such that we could annotate the spots to layers as you can see under the spot-level data tab. Once we annotated each spot to a layer, we compressed the information by a pseudo-bulking approach into layer-level data. We then analyzed the expression through a set of models whose results you can also explore through this web application. Finally, you can upload your own gene sets of interest as well as layer enrichment statistics and compare them with our LIBD Human DLPFC Visium dataset.

If you are interested in running this web application locally, you can do so thanks to the spatialLIBD R/Bioconductor package that powers this web application as shown below.

## Run this web application locally
spatialLIBD::run_app()

## You will have more control about the length of the
## session and memory usage.

## You could also use this function to visualize your
## own data given some requirements described
## in detail in the package vignette documentation
## at http://research.libd.org/spatialLIBD/.

Shiny website mirrors

R/Bioconductor package

The spatialLIBD package contains functions for:

  • Accessing the spatial transcriptomics data from the LIBD Human Pilot project (code on GitHub) generated with the Visium platform from 10x Genomics. The data is retrieved from Bioconductor’s ExperimentHub.
  • Visualizing the spot-level spatial gene expression data and clusters.
  • Inspecting the data interactively either on your computer or through spatial.libd.org/spatialLIBD/.

For more details, please check the documentation website or the Bioconductor package landing page here.

Installation instructions

Get the latest stable R release from CRAN. Then install spatialLIBD using from Bioconductor the following code:

if (!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")

BiocManager::install("spatialLIBD")

Access the data

Through the spatialLIBD package you can access the processed data in it’s final R format. However, we also provide a table of links so you can download the raw data we received from 10x Genomics.

Processed data

Using spatialLIBD you can access the Human DLPFC spatial transcriptomics data from the 10x Genomics Visium platform. For example, this is the code you can use to access the layer-level data. For more details, check the help file for fetch_data().

## Load the package
library('spatialLIBD')

## Download the spot-level data
sce <- fetch_data(type = 'sce')
#> Loading objects:
#>   sce

## This is a SingleCellExperiment object
sce
#> class: SingleCellExperiment 
#> dim: 33538 47681 
#> metadata(1): image
#> assays(2): counts logcounts
#> rownames(33538): ENSG00000243485 ENSG00000237613 ... ENSG00000277475
#>   ENSG00000268674
#> rowData names(9): source type ... gene_search is_top_hvg
#> colnames(47681): AAACAACGAATAGTTC-1 AAACAAGTATCTCCCA-1 ...
#>   TTGTTTCCATACAACT-1 TTGTTTGTGTAAATTC-1
#> colData names(73): barcode sample_name ... pseudobulk_UMAP_spatial
#>   markers_UMAP_spatial
#> reducedDimNames(6): PCA TSNE_perplexity50 ... TSNE_perplexity80
#>   UMAP_neighbors15
#> spikeNames(0):
#> altExpNames(0):

## Note the memory size
pryr::object_size(sce)
#> 2.08 GB

## Remake the logo image with histology information
sce_image_clus(
    sce = sce,
    clustervar = 'layer_guess_reordered',
    sampleid = '151673',
    colors = libd_layer_colors,
    ... = ' DLPFC Human Brain Layers\nMade with github.com/LieberInstitute/spatialLIBD'
)

Raw data

You can access all the raw data through Globus (jhpce#HumanPilot10x). Furthermore, below you can find the links to the raw data we received from 10x Genomics.

SampleID h5_filtered h5_raw image_full image_hi image_lo loupe HTML_report
151507 AWS AWS AWS AWS AWS AWS GitHub
151508 AWS AWS AWS AWS AWS AWS GitHub
151509 AWS AWS AWS AWS AWS AWS GitHub
151510 AWS AWS AWS AWS AWS AWS GitHub
151669 AWS AWS AWS AWS AWS AWS GitHub
151670 AWS AWS AWS AWS AWS AWS GitHub
151671 AWS AWS AWS AWS AWS AWS GitHub
151672 AWS AWS AWS AWS AWS AWS GitHub
151673 AWS AWS AWS AWS AWS AWS GitHub
151674 AWS AWS AWS AWS AWS AWS GitHub
151675 AWS AWS AWS AWS AWS AWS GitHub
151676 AWS AWS AWS AWS AWS AWS GitHub

Citation

Below is the citation output from using citation('spatialLIBD') in R. Please run this yourself to check for any updates on how to cite spatialLIBD.

citation('spatialLIBD')
#> 
#> Collado-Torres L, Maynard KR, Jaffe AE (2020). _LIBD Visium spatial
#> transcriptomics human pilot data inspector_. doi:
#> 10.18129/B9.bioc.spatialLIBD (URL:
#> https://doi.org/10.18129/B9.bioc.spatialLIBD),
#> https://github.com/LieberInstitute/spatialLIBD - R package version
#> 1.0.0, <URL: http://www.bioconductor.org/packages/spatialLIBD>.
#> 
#> Maynard KR, Collado-Torres L, Weber LM, Uytingco C, Barry BK, Williams
#> SR, II JLC, Tran MN, Besich Z, Tippani M, Chew J, Yin Y, Kleinman JE,
#> Hyde TM, Rao N, Hicks SC, Martinowich K, Jaffe AE (2020).
#> "Transcriptome-scale spatial gene expression in the human dorsolateral
#> prefrontal cortex." _bioRxiv_. doi: 10.1101/2020.02.28.969931 (URL:
#> https://doi.org/10.1101/2020.02.28.969931), <URL:
#> https://www.biorxiv.org/content/10.1101/2020.02.28.969931v1>.
#> 
#> To see these entries in BibTeX format, use 'print(<citation>,
#> bibtex=TRUE)', 'toBibtex(.)', or set
#> 'options(citation.bibtex.max=999)'.

HumanPilot code

Re-shaping your data to our structure

As described in the spatialLIBD vignette, you can see the scripts in this repository for re-shaping your data to look like ours. That is.

  • reorganize_folder.R available here re-organizes the raw data we were sent by 10x Genomics.
  • Layer_Notebook.R available here reads in the Visium data and builds a list of RangeSummarizedExperiment() objects from SummarizedExperiment, one per sample (image) that is eventually saved as Human_DLPFC_Visium_processedData_rseList.rda.
  • convert_sce.R available here reads in Human_DLPFC_Visium_processedData_rseList.rda and builds an initial sce object with image data under metadata(sce)$image which is a single data.frame. Subsetting doesn’t automatically subset the image, so you have to do it yourself when plotting as is done by sce_image_clus_p() and sce_image_gene_p(). Having the data from all images in a single object allows you to use the spot-level data from all images to compute clusters and do other similar analyses to the ones you would do with sc/snRNA-seq data. The script creates the Human_DLPFC_Visium_processedData_sce.Rdata file.
  • sce_scran.R available here then uses scran to read in Human_DLPFC_Visium_processedData_sce.Rdata, compute the highly variable genes (stored in our final sce object at rowData(sce)$is_top_hvg), perform dimensionality reduction (PCA, TSNE, UMAP) and identify clusters using the data from all images. The resulting data is then stored as Human_DLPFC_Visium_processedData_sce_scran.Rdata and is the main object used throughout our analysis code (Maynard, Collado-Torres, Weber, Uytingco, et al., 2020).
  • make-data_spatialLIBD.R available in the source version of spatialLIBD and online here is the script that reads in Human_DLPFC_Visium_processedData_sce_scran.Rdata as well as some other outputs from our analysis and combines them into the final sce and sce_layer objects provided by spatialLIBD (Collado-Torres, Maynard, and Jaffe, 2020). This script simplifies some operations in order to simplify the code behind the shiny application provided by spatialLIBD.

10X directory

Contains some of the raw files provided by 10X. Given their size, we only included the small ones here. ## Analysis directory

The README.md was the one we initially prepared for our collaborators at an early stage of the project. That README file described some of our initial explorations using packages such as scran, zinbwave and other approaches such as using k-means with X/Y spatial information. These analyses were not used for our manuscript beyond creating the sce object we previously described.

The 10x Genomics file structure is replicated inside Histology where we saved the image segmentation analysis output to estimate the number of cells per spot. This involved running some histology image segmentation software and the counting code that requires our file structure (sgeID input).

The main layer-level analysis code is located at Layer_Guesses, for example layer_specificity.R is the R script for pseudo-bulking the spot-level data to create the layer-level data. The spatialLIBD layer annotation files are saved in the First_Round and Second_Round directories which you can upload to the shiny web application.

We also include directories with code for processing external datasets such as he_layers, allen_data, hafner_vglut.

We would like to highlight that a lot of the plotting code and functionality from these scripts has been implemented in spatialLIBD which would make a lot of our analysis simpler. Finally, for reproducibility purposes we included the R session information in many of our R scripts. Although in general we used R 3.6.1 and 3.6.2 with Bioconductor release 3.10.

outputs directory

Contains outputs from the different unsupervised, semi-supervised, known gene marker based and other clustering results. The analysis code that generates these CSV files is located inside R Markdown files at the Analysis directory such as SpatialDE_clustering.Rmd.

Bibliography

[1] L. Collado-Torres, K. R. Maynard, and A. E. Jaffe. LIBD Visium spatial transcriptomics human pilot data inspector. https://github.com/LieberInstitute/spatialLIBD - R package version 1.0.0. 2020. DOI: 10.18129/B9.bioc.spatialLIBD. <URL: http://www.bioconductor.org/packages/spatialLIBD>.

[2] K. R. Maynard, L. Collado-Torres, L. M. Weber, C. Uytingco, et al. “Transcriptome-scale spatial gene expression in the human dorsolateral prefrontal cortex”. In: bioRxiv (2020). DOI: 10.1101/2020.02.28.969931. <URL: https://www.biorxiv.org/content/10.1101/2020.02.28.969931v1>.

Internal

  • JHPCE location: /dcl02/lieber/ajaffe/SpatialTranscriptomics/HumanPilot
  • Main sce R object file: /dcl02/lieber/ajaffe/SpatialTranscriptomics/HumanPilot/Analysis/Human_DLPFC_Visium_processedData_sce_scran.Rdata.
Note that the project description data, including the texts, logos, images, and/or trademarks, for each open source project belongs to its rightful owner. If you wish to add or remove any projects, please contact us at [email protected].