68 datasets found
  1. Data, R code and output Seurat Objects for single cell RNA-seq analysis of...

    • figshare.com
    application/gzip
    Updated May 31, 2023
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Yunshun Chen; Gordon Smyth (2023). Data, R code and output Seurat Objects for single cell RNA-seq analysis of human breast tissues [Dataset]. http://doi.org/10.6084/m9.figshare.17058077.v1
    Explore at:
    application/gzipAvailable download formats
    Dataset updated
    May 31, 2023
    Dataset provided by
    Figsharehttp://figshare.com/
    figshare
    Authors
    Yunshun Chen; Gordon Smyth
    License

    Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
    License information was derived automatically

    Description

    This dataset contains all the Seurat objects that were used for generating all the figures in Pal et al. 2021 (https://doi.org/10.15252/embj.2020107333). All the Seurat objects were created under R v3.6.1 using the Seurat package v3.1.1. The detailed information of each object is listed in a table in Chen et al. 2021.

  2. Processed, annotated, seurat object

    • zenodo.org
    • data.niaid.nih.gov
    bin
    Updated Nov 16, 2023
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Cenk Celik; Cenk Celik; Guillaume Thibault; Guillaume Thibault (2023). Processed, annotated, seurat object [Dataset]. http://doi.org/10.5281/zenodo.7608212
    Explore at:
    binAvailable download formats
    Dataset updated
    Nov 16, 2023
    Dataset provided by
    Zenodohttp://zenodo.org/
    Authors
    Cenk Celik; Cenk Celik; Guillaume Thibault; Guillaume Thibault
    Description

    The dataset contains an integrated, annotated Seurat v4 object. One can load the dataset into the R environment using the code below:

    seurat_obj <- readRDS('PATH/TO/DOWNLOAD/seurat.rds')

    The object has three assays: (I) RNA, (II) SCT and (III) integrated.

  3. Scripts for Analysis

    • figshare.com
    txt
    Updated Jul 18, 2018
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Sneddon Lab UCSF (2018). Scripts for Analysis [Dataset]. http://doi.org/10.6084/m9.figshare.6783569.v2
    Explore at:
    txtAvailable download formats
    Dataset updated
    Jul 18, 2018
    Dataset provided by
    figshare
    Authors
    Sneddon Lab UCSF
    License

    MIT Licensehttps://opensource.org/licenses/MIT
    License information was derived automatically

    Description

    Scripts used for analysis of V1 and V2 Datasets.seurat_v1.R - initialize seurat object from 10X Genomics cellranger outputs. Includes filtering, normalization, regression, variable gene identification, PCA analysis, clustering, tSNE visualization. Used for v1 datasets. merge_seurat.R - merge two or more seurat objects into one seurat object. Perform linear regression to remove batch effects from separate objects. Used for v1 datasets. subcluster_seurat_v1.R - subcluster clusters of interest from Seurat object. Determine variable genes, perform regression and PCA. Used for v1 datasets.seurat_v2.R - initialize seurat object from 10X Genomics cellranger outputs. Includes filtering, normalization, regression, variable gene identification, and PCA analysis. Used for v2 datasets. clustering_markers_v2.R - clustering and tSNE visualization for v2 datasets. subcluster_seurat_v2.R - subcluster clusters of interest from Seurat object. Determine variable genes, perform regression and PCA analysis. Used for v2 datasets.seurat_object_analysis_v1_and_v2.R - downstream analysis and plotting functions for seurat object created by seurat_v1.R or seurat_v2.R. merge_clusters.R - merge clusters that do not meet gene threshold. Used for both v1 and v2 datasets. prepare_for_monocle_v1.R - subcluster cells of interest and perform linear regression, but not scaling in order to input normalized, regressed values into monocle with monocle_seurat_input_v1.R monocle_seurat_input_v1.R - monocle script using seurat batch corrected values as input for v1 merged timecourse datasets. monocle_lineage_trace.R - monocle script using nUMI as input for v2 lineage traced dataset. monocle_object_analysis.R - downstream analysis for monocle object - BEAM and plotting. CCA_merging_v2.R - script for merging v2 endocrine datasets with canonical correlation analysis and determining the number of CCs to include in downstream analysis. CCA_alignment_v2.R - script for downstream alignment, clustering, tSNE visualization, and differential gene expression analysis.

  4. Data used in SeuratIntegrate paper

    • zenodo.org
    application/gzip, bin +1
    Updated Jan 23, 2025
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Florian Specque; Florian Specque; Macha Nikolski; Macha Nikolski; Domitille Chalopin; Domitille Chalopin (2025). Data used in SeuratIntegrate paper [Dataset]. http://doi.org/10.5281/zenodo.14288361
    Explore at:
    txt, bin, application/gzipAvailable download formats
    Dataset updated
    Jan 23, 2025
    Dataset provided by
    Zenodohttp://zenodo.org/
    Authors
    Florian Specque; Florian Specque; Macha Nikolski; Macha Nikolski; Domitille Chalopin; Domitille Chalopin
    License

    Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
    License information was derived automatically

    Description

    This repository stores the data used to generate hepatocellular carcinoma analyses in the paper presenting SeuratIntegrate. It contains the scripts to reproduce the figure 1 presented in the article.

    To be able to fully reproduce the results from the paper, one shoud:

    • download all the files
    • install R 4.3.3, with correspondig base R packages (stats, graphics, grDevices, utils, datasets, methods and base)
    • install R packages listed in the file sessionInfo.out
    • install the provided version of SeuratIntegrate. In an R session, run:
    remotes::install_local("path/to/SeuratIntegrate_0.4.0.tar.gz")
    • install (mini)conda (we used version 23.11.0) if not already
    • install conda environments:
    conda create -n SeuratIntegrate_bbknn –file SeuratIntegrate_bbknn_package-list.txt
    conda create -n SeuratIntegrate_scanorama –file SeuratIntegrate_scanorama_package-list.txt
    • make them usable by SeuratIntegrate by opening an R session and:
    library(SeuratIntegrate)
    
    UpdateEnvCache("bbknn", conda.env = "SeuratIntegrate_bbknn", conda.env.is.path = FALSE)
    UpdateEnvCache("scanorama", conda.env = "SeuratIntegrate_scanorama", conda.env.is.path = FALSE)

    Once done, the file integrate.R should produce reproducible results. Note that lines 3 to 6 from integrate.R should be adapted to the user's setup.

  5. f

    185 shared genes in DEGs related to mouse AD.

    • plos.figshare.com
    xlsx
    Updated Nov 26, 2024
    + more versions
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Rong He; Qiang Zhang; Limei Wang; Yiwen Hu; Yue Qiu; Jia Liu; Dingyun You; Jishuai Cheng; Xue Cao (2024). 185 shared genes in DEGs related to mouse AD. [Dataset]. http://doi.org/10.1371/journal.pone.0311374.s007
    Explore at:
    xlsxAvailable download formats
    Dataset updated
    Nov 26, 2024
    Dataset provided by
    PLOS ONE
    Authors
    Rong He; Qiang Zhang; Limei Wang; Yiwen Hu; Yue Qiu; Jia Liu; Dingyun You; Jishuai Cheng; Xue Cao
    License

    Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
    License information was derived automatically

    Description

    ObjectiveTo guide animal experiments, we investigated the similarities and differences between humans and mice in aging and Alzheimer’s disease (AD) at the single-nucleus RNA sequencing (snRNA-seq) or single-cell RNA sequencing (scRNA-seq) level.MethodsMicroglia cells were extracted from dataset GSE198323 of human post-mortem hippocampus. The distributions and proportions of microglia subpopulation cell numbers related to AD or age were compared. This comparison was done between GSE198323 for humans and GSE127892 for mice, respectively. The Seurat R package and harmony R package were used for data analysis and batch effect correction. Differentially expressed genes (DEGs) were identified by FindMarkers function with MAST test. Comparative analyses were conducted on shared genes in DEGs associated with age and AD. The analyses were done between human and mouse using various bioinformatics techniques. The analysis of genes in DEGs related to age was conducted. Similarly, the analysis of genes in DEGs related to AD was performed. Cross-species analyses were conducted using orthologous genes. Comparative analyses of pseudotime between humans and mice were performed using Monocle2.Results(1) Similarities: The proportion of microglial subpopulation Cell_APOE/Apoe shows consistent trends, whether in AD or normal control (NC) groups in both humans and mice. The proportion of Cell_CX3CR1/Cx3cr1, representing homeostatic microglia, remains stable with age in NC groups across species. Tuberculosis and Fc gamma R-mediated phagocytosis pathways are shared in microglia responses to age and AD across species, respectively. (2) Differences: IL1RAPL1 and SPP1 as marker genes are more identifiable in human microglia compared to their mouse counterparts. Most genes of DEGs associated with age or AD exhibit different trends between humans and mice. Pseudotime analyses demonstrate varying cell density trends in microglial subpopulations, depending on age or AD across species.ConclusionsMouse Apoe and Cell_Apoe maybe serve as proxies for studying human AD, while Cx3cr1 and Cell_Cx3cr1 are suitable for human aging studies. However, AD mouse models (App_NL_G_F) have limitations in studying human genes like IL1RAPL1 and SPP1 related to AD. Thus, mouse models cannot fully replace human samples for AD and aging research.

  6. Z

    Single-cell Atlas Reveals Diagnostic Features Predicting Progressive Drug...

    • data.niaid.nih.gov
    • explore.openaire.eu
    • +1more
    Updated Sep 7, 2023
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Chan Zhu En (2023). Single-cell Atlas Reveals Diagnostic Features Predicting Progressive Drug Resistance in Chronic Myeloid Leukemia [Dataset]. https://data.niaid.nih.gov/resources?id=zenodo_5118610
    Explore at:
    Dataset updated
    Sep 7, 2023
    Dataset provided by
    Sin Tiong Ong
    William Ying Khee Hwang
    Florian Schmidt
    Owen Rackham
    Shyam Prabhakar
    Pavanish Kumar
    Lee Kian Leong
    Sudipto Bari
    Salvatore Albani
    Prasanna Nori Venkatesh
    Vaidehi Krishnan
    Meera Makheja
    Charles Chuah
    Ahmad Lajam
    Alice Man Sze Cheung
    John Ouyang
    Zahid Nawaz
    Chan Zhu En
    Description

    This archive contains data of scRNAseq and CyTOF in form of Seurat objects, txt and csv files as well as R scripts for data analysis and Figure generation.

    A summary of the content is provided in the following.

    R scripts

    Script to run Machine learning models predicting group specific marker genes: CML_Find_Markers_Zenodo.R Script to reproduce the majority of Main and Supplementary Figures shown in the manuscript: CML_Paper_Figures_Zenodo.R Script to run inferCNV analysis: inferCNV_Zenodo.R Script to plot NATMI analysis results:NATMI_CvsA_FC0.32_Updown_Column_plot_Zenodo.R Script to conduct sub-clustering and filtering of NK cells NK_Marker_Detection_Zenodo.R

    Helper scripts for plotting and DEG calculation:ComputePairWiseDE_v2.R, Seurat_DE_Heatmap_RCA_Style.R

    RDS files

    General scRNA-seq Seurat objects:

    scRNA-seq seurat object after QC, and cell type annotation used for most analysis in the manuscript: DUKE_DataSet_Doublets_Removed_Relabeled.RDS

    scRNA-seq including findings e.g. from NK analysis used in the shiny app: DUKE_final_for_Shiny_App.rds

    Neighborhood enrichment score computed for group A across all HSPCs: Enrichment_score_global_groupA.RDS

    UMAP coordinates used in the article: Layout_2D_nNeighbours_25_Metric_cosine_TCU_removed.RDS

    SCENIC files:

    Regulon set used in SCENIC: 2.6_regulons_asGeneSet.Rds

    AUC values computed for regulons: 3.4_regulonAUC.Rds

    MetaData used in SCENIC cellInfo.Rds

    Group specific regulons for LCS: groupSpecificRegulonsBCRAblP.RDS

    Patient specific regulons for LSC: patientSpecificRegulonsBCRAblP.RDS

    Patient specificity score for LSC: PatientSpecificRegulonSpecificityScoreBCRAblP.RDS

    Regulon specificty score for LSC: RegulonSpecificityScoreBCRAblP.RDS

    BCR-ABL1 inference:

    HSC with inferred BCR-ABL1 label: HSCs_CML_with_BCR-Abl_label.RDS

    UMAP for HSC with inferred BCR-ABL1 label: HSCs_CML_with_BCR-Abl_label_UMAP.RDS

    HSPCs with BCR-ABL1 module scores: HSPC_metacluster_74K_with_modscore_27thmay.RDS

    NK sub-clustering and filtering:

    NK object with module scores: NK_8617cells_with_modscore_1stjune.RDS

    Feature genes for NK cells computed with DubStepR: NK_Cells_DubStepR

    NK cells Seurat object excluding contaminating T and B cells: NK_cells_T_B_17_removed.RDS

    NK Seurat object including neighbourhood enrichment score calculations: NK_seurat_object_with_enrichment_labels_V2.RDS

    txt and csv files:

    Proportions per cluster calculated from CyTOF: CyTOF_Proportions.txt

    Correlation between scRNAseq and CyTOF cell type abundance: scRNAseq_Cor_Cytof.txt

    Correlation between manual gating and FlowSOM clustering: Manual_vs_FlowSOM.txt

    GSEA results:

    HSPC, HSC and LSC results: FINAL_GSEA_DATA_For_GGPLOT.txt

    NK: NK_For_Plotting.txt

    TFRC and HLA expression: TFRC_and_HLA_Values.txt

    NATMI result files:

    UP-regulated_mean.csv

    DOWN-regulated_mean.csv

    Gene position file used in inferCNV: inferCNV_gene_positions_hg38.txt

    Module scores for NK subclusters per cell: NK_Supplementary_Module_Scores.csv

    Compressed folders:

    All CyTOF raw data files: CyTOF_Data_raw.zip

    Results of the patient-based classifier: PatientwiseClassifier.zip

    Results of the single-cell based classifier: SingleCellClassifierResults.zip

    For general new data analysis approaches, we recommend the readers to use the Seruat object stored in DUKE_final_for_Shiny_App.rds or to use the shiny app(http://scdbm.ddnetbio.com/) and perform further analysis from there.

    RAW data is available at EGA upon request using Study ID: EGAS00001005509

  7. H

    Dan R Laks Code of Seurat analysis integration of 20 GBM from Neftel et al.,...

    • dataverse.harvard.edu
    Updated Nov 21, 2021
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Dan Laks (2021). Dan R Laks Code of Seurat analysis integration of 20 GBM from Neftel et al., 2019 [Dataset]. http://doi.org/10.7910/DVN/FODWRV
    Explore at:
    CroissantCroissant is a format for machine-learning datasets. Learn more about this at mlcommons.org/croissant.
    Dataset updated
    Nov 21, 2021
    Dataset provided by
    Harvard Dataverse
    Authors
    Dan Laks
    License

    CC0 1.0 Universal Public Domain Dedicationhttps://creativecommons.org/publicdomain/zero/1.0/
    License information was derived automatically

    Description

    Code for RSTUDIO with Seurat package integration and analysis of scRNA-Seq data for 20 GBM from Neftel et al., 2019

  8. l

    cellCounts

    • opal.latrobe.edu.au
    bin
    Updated Dec 19, 2022
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Yang Liao; Dinesh Raghu; Bhupinder Pal; Lisa Mielke; Wei Shi (2022). cellCounts [Dataset]. http://doi.org/10.26181/21588276.v3
    Explore at:
    binAvailable download formats
    Dataset updated
    Dec 19, 2022
    Dataset provided by
    La Trobe
    Authors
    Yang Liao; Dinesh Raghu; Bhupinder Pal; Lisa Mielke; Wei Shi
    License

    Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
    License information was derived automatically

    Description

    This page includes the data and code necessary to reproduce the results of the following paper: Yang Liao, Dinesh Raghu, Bhupinder Pal, Lisa Mielke and Wei Shi. cellCounts: fast and accurate quantification of 10x Chromium single-cell RNA sequencing data. Under review. A Linux computer running an operating system of CentOS 7 (or later) or Ubuntu 20.04 (or later) is recommended for running this analysis. The computer should have >2 TB of disk space and >64 GB of RAM. The following software packages need to be installed before running the analysis. Software executables generated after installation should be included in the $PATH environment variable.

    R (v4.0.0 or newer) https://www.r-project.org/ Rsubread (v2.12.2 or newer) http://bioconductor.org/packages/3.16/bioc/html/Rsubread.html CellRanger (v6.0.1) https://support.10xgenomics.com/single-cell-gene-expression/software/overview/welcome STARsolo (v2.7.10a) https://github.com/alexdobin/STAR sra-tools (v2.10.0 or newer) https://github.com/ncbi/sra-tools Seurat (v3.0.0 or newer) https://satijalab.org/seurat/ edgeR (v3.30.0 or newer) https://bioconductor.org/packages/edgeR/ limma (v3.44.0 or newer) https://bioconductor.org/packages/limma/ mltools (v0.3.5 or newer) https://cran.r-project.org/web/packages/mltools/index.html

    Reference packages generated by 10x Genomics are also required for this analysis and they can be downloaded from the following link (2020-A version for individual human and mouse reference packages should be selected): https://support.10xgenomics.com/single-cell-gene-expression/software/downloads/latest After all these are done, you can simply run the shell script ‘test-all-new.bash’ to perform all the analyses carried out in the paper. This script will automatically download the mixture scRNA-seq data from the SRA database, and it will output a text file called ‘test-all.log’ that contains all the screen outputs and speed/accuracy results of CellRanger, STARsolo and cellCounts.

  9. f

    234 shared genes in DEGs related to human AD.

    • plos.figshare.com
    xlsx
    Updated Nov 26, 2024
    + more versions
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Rong He; Qiang Zhang; Limei Wang; Yiwen Hu; Yue Qiu; Jia Liu; Dingyun You; Jishuai Cheng; Xue Cao (2024). 234 shared genes in DEGs related to human AD. [Dataset]. http://doi.org/10.1371/journal.pone.0311374.s006
    Explore at:
    xlsxAvailable download formats
    Dataset updated
    Nov 26, 2024
    Dataset provided by
    PLOS ONE
    Authors
    Rong He; Qiang Zhang; Limei Wang; Yiwen Hu; Yue Qiu; Jia Liu; Dingyun You; Jishuai Cheng; Xue Cao
    License

    Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
    License information was derived automatically

    Description

    ObjectiveTo guide animal experiments, we investigated the similarities and differences between humans and mice in aging and Alzheimer’s disease (AD) at the single-nucleus RNA sequencing (snRNA-seq) or single-cell RNA sequencing (scRNA-seq) level.MethodsMicroglia cells were extracted from dataset GSE198323 of human post-mortem hippocampus. The distributions and proportions of microglia subpopulation cell numbers related to AD or age were compared. This comparison was done between GSE198323 for humans and GSE127892 for mice, respectively. The Seurat R package and harmony R package were used for data analysis and batch effect correction. Differentially expressed genes (DEGs) were identified by FindMarkers function with MAST test. Comparative analyses were conducted on shared genes in DEGs associated with age and AD. The analyses were done between human and mouse using various bioinformatics techniques. The analysis of genes in DEGs related to age was conducted. Similarly, the analysis of genes in DEGs related to AD was performed. Cross-species analyses were conducted using orthologous genes. Comparative analyses of pseudotime between humans and mice were performed using Monocle2.Results(1) Similarities: The proportion of microglial subpopulation Cell_APOE/Apoe shows consistent trends, whether in AD or normal control (NC) groups in both humans and mice. The proportion of Cell_CX3CR1/Cx3cr1, representing homeostatic microglia, remains stable with age in NC groups across species. Tuberculosis and Fc gamma R-mediated phagocytosis pathways are shared in microglia responses to age and AD across species, respectively. (2) Differences: IL1RAPL1 and SPP1 as marker genes are more identifiable in human microglia compared to their mouse counterparts. Most genes of DEGs associated with age or AD exhibit different trends between humans and mice. Pseudotime analyses demonstrate varying cell density trends in microglial subpopulations, depending on age or AD across species.ConclusionsMouse Apoe and Cell_Apoe maybe serve as proxies for studying human AD, while Cx3cr1 and Cell_Cx3cr1 are suitable for human aging studies. However, AD mouse models (App_NL_G_F) have limitations in studying human genes like IL1RAPL1 and SPP1 related to AD. Thus, mouse models cannot fully replace human samples for AD and aging research.

  10. o

    Introduction to single cell RNAseq analysis: supplementary material

    • explore.openaire.eu
    Updated Apr 14, 2023
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Jose Alejandro Romero Herrera; Samuele Soraggi (2023). Introduction to single cell RNAseq analysis: supplementary material [Dataset]. http://doi.org/10.5281/zenodo.11519737
    Explore at:
    Dataset updated
    Apr 14, 2023
    Authors
    Jose Alejandro Romero Herrera; Samuele Soraggi
    Description

    This archive contains supplementary material used in the workshop "Introduction to single cell RNAseq analysis" taught by the Danish National Sandbox for Health Data Science. The course repo can be found on Github. Data.zip contains 6 10x runs on Spermatogonia development. 3 from healthy individuals and 3 from azoospermic individuals. Data has been already preprocessed using cellranger and can be loaded using Seurat (R) or scanpy (python). Slides.zip contains slides explaning theory regarding single cell RNAseq data analysis Notebooks.zip contains Rmarkdown files to follow the course in using R in Rstudio. Latest version of the notebooks

  11. E

    Single-cell transcriptomics uncovers zonation of function in the mesenchyme...

    • find.data.gov.scot
    • dtechtive.com
    txt
    Updated Feb 12, 2020
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    University of Edinburgh Centre for Inflammation Research (2020). Single-cell transcriptomics uncovers zonation of function in the mesenchyme during liver fibrosis - Seurat objects [Dataset]. http://doi.org/10.7488/ds/2769
    Explore at:
    txt(0.0166 MB), txt(0.0013 MB)Available download formats
    Dataset updated
    Feb 12, 2020
    Dataset provided by
    University of Edinburgh Centre for Inflammation Research
    License

    Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
    License information was derived automatically

    Area covered
    UNITED KINGDOM
    Description

    We profile the transcriptomes of ~30,000 mouse single cells to deconvolve the hepatic mesenchyme in healthy and fibrotic liver at high resolution. We reveal spatial zonation of hepatic stellate cells across the liver lobule, designated portal vein-associated HSC and central vein-associated HSC, and uncover an equivalent functional zonation in a mouse model of centrilobular fibrosis. Our work illustrates the power of single-cell transcriptomics to resolve key collagen-producing cells driving liver fibrosis with high precision. We provide the contents of these data as Seurat R objects.

  12. S

    scRNA-seq data of lung cancer

    • scidb.cn
    Updated Jul 21, 2022
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Weimin Li (2022). scRNA-seq data of lung cancer [Dataset]. http://doi.org/10.57760/sciencedb.02028
    Explore at:
    CroissantCroissant is a format for machine-learning datasets. Learn more about this at mlcommons.org/croissant.
    Dataset updated
    Jul 21, 2022
    Dataset provided by
    Science Data Bank
    Authors
    Weimin Li
    License

    Attribution-NonCommercial 4.0 (CC BY-NC 4.0)https://creativecommons.org/licenses/by-nc/4.0/
    License information was derived automatically

    Description

    we collected 40 tumor and adjacent normal tissue samples from 19 pathologically diagnosed NSCLC patients (10 LUAD and 9 LUSC) during surgical resections, and rapidly digested the tissues to obtain single-cell suspensions and constructed the cDNA libraries of these samples within 24 hours using the protocol of 10X gennomic. These libraries were sequenced on the Illumina NovaSeq 6000 platform. Finally we obtained the raw gene expression matrices were generated using CellRanger (version 3.0.1). Information was processed in R (version 3.6.0) using the Seurat R package (version 2.3.4).

  13. d

    Sp 3dpf scRNA-Seq

    • datadryad.org
    • zenodo.org
    zip
    Updated Dec 10, 2021
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Maria Immacolata Arnone; Periklis Paganos; Danila Voronov; Jacob Musser; Detlev Arendt (2021). Sp 3dpf scRNA-Seq [Dataset]. http://doi.org/10.5061/dryad.n5tb2rbvz
    Explore at:
    zipAvailable download formats
    Dataset updated
    Dec 10, 2021
    Dataset provided by
    Dryad
    Authors
    Maria Immacolata Arnone; Periklis Paganos; Danila Voronov; Jacob Musser; Detlev Arendt
    Time period covered
    2021
    Description

    Identifying the molecular fingerprint of organismal cell types is key for understanding their function and evolution. Here, we use single cell RNA sequencing (scRNA-seq) to survey the cell types of the sea urchin early pluteus larva, representing an important developmental transition from non-feeding to feeding larva. We identify 21 distinct cell clusters, representing cells of the digestive, skeletal, immune, and nervous systems. Further subclustering of these reveal a highly detailed portrait of cell diversity across the larva, including the identification of neuronal cell types. We then validate important gene regulatory networks driving sea urchin development and reveal new domains of activity within the larval body. Focusing on neurons that co-express Pdx-1 and Brn1/2/4, we identify an unprecedented number of transcription factors shared by this population of neurons in sea urchin and vertebrate pancreatic cells. Using differential expression results from Pdx-1 knockdown experiment...

  14. d

    Dawnn benchmarking dataset: Mouse embryo cells processing and label...

    • b2find.dkrz.de
    Updated Oct 24, 2023
    + more versions
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    (2023). Dawnn benchmarking dataset: Mouse embryo cells processing and label simulation - Dataset - B2FIND [Dataset]. https://b2find.dkrz.de/dataset/95ae34cf-242e-52a6-83ab-1be3237cdd96
    Explore at:
    Dataset updated
    Oct 24, 2023
    Description

    This project is a collection of files to allow users to reproduce the model development and benchmarking in "Dawnn: single-cell differential abundance with neural networks" (Hall and Castellano, under review). Dawnn is a tool for detecting differential abundance in single-cell RNAseq datasets. It is available as an R package here. Please contact us if you are unable to reproduce any of the analysis in our paper. The files in this collection correspond to the benchmarking dataset based on single-cell RNAseq of mouse emrbyo cells. FILES: Input data Dataset from: "A single-cell molecular map of mouse gastrulation and early organogenesis". Nature 566, pp490–495 (2019). The input data is loaded from the MouseGastrulationData R package. We upload here the RDS file generated by loading the dataset in process_mouse_cells.R in case the R package becomes unavailable MouseGastrulationData_loaded_dataset.RDS Dataset loaded from MouseGastrulationData R package in process_mouse_cells.R (in call to EmbryoAtlasData function). Data processing code process_mouse_cells.R Generates benchmarking dataset from input data. (Loads input data; Runs the standard single-cell RNAseq pipeline). Follows Dann et al. Resulting dataset saved as mouse_gastrulation_data_regen.RDS. simulate_mouse_pc1_Rscript.R R code to simulate P(Condition_1)s for benchmarking. simulate_mouse_pc1_bash.sh Bash script to execute simulate_mouse_pc1_Rscript.R. Outputs stored in benchmark_dataset_mouse_pc1s_regen.csv. simulate_mouse_labels_Rscript.R R code to simulate labels for benchmarking. simulate_mouse_labels_bash.sh Bash script to execute simulate_mouse_labels_Rscript.R. Outputs stored in benchmark_dataset_mouse.csv. Resulting datasets mouse_gastrulation_data_regen.RDS Seurat dataset generated by process_mouse_cells.R. benchmark_dataset_mouse.csv Cell labels generated by simulate_mouse_labels_bash.sh. benchmark_dataset_mouse_pc1s_regen.csv P(Condition_1)s generated by simulate_mouse_pc1_bash.sh.

  15. m

    Multifocal, multiphenotypic tumours arising from an MTOR mutation acquired...

    • data.mendeley.com
    Updated Dec 8, 2023
    + more versions
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Chloe Pacyna (2023). Multifocal, multiphenotypic tumours arising from an MTOR mutation acquired in early embryogenesis - scRNA-seq dataset [Dataset]. http://doi.org/10.17632/6fg25sm5g8.1
    Explore at:
    Dataset updated
    Dec 8, 2023
    Authors
    Chloe Pacyna
    License

    Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
    License information was derived automatically

    Description

    This R dataset contains the Seurat object containing scRNA-seq counts and metadata from a patient with multifocal renal tumors. It is associated with the paper "Multifocal, multiphenotypic tumours arising from an MTOR mutation acquired in early embryogenesis"

  16. d

    Data from: Human tau mutations in cerebral organoids induce a progressive...

    • dataone.org
    • search.dataone.org
    • +3more
    Updated Nov 29, 2023
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Stella M.K. Glasauer; Susan K. Goderie; Jennifer N. Rauch; Elmer Guzman; Morgane Audouard; Taylor Bertucci; Shona Joy; Emma Rommelfanger; Gabriel Luna; Erica Keane-Rivera; Steven Lotz; Susan Borden; Aaron M. Armando; Oswald Quehenberger; Sally Temple; Kenneth S. Kosik (2023). Human tau mutations in cerebral organoids induce a progressive dyshomeostasis of cholesterol [Dataset]. https://dataone.org/datasets/sha256%3Ad6a83eae2ae1296ea49ec6e0d9b042bcd4937c3005eb1f6ba6130ec2d31890eb
    Explore at:
    Dataset updated
    Nov 29, 2023
    Dataset provided by
    Dryad Digital Repository
    Authors
    Stella M.K. Glasauer; Susan K. Goderie; Jennifer N. Rauch; Elmer Guzman; Morgane Audouard; Taylor Bertucci; Shona Joy; Emma Rommelfanger; Gabriel Luna; Erica Keane-Rivera; Steven Lotz; Susan Borden; Aaron M. Armando; Oswald Quehenberger; Sally Temple; Kenneth S. Kosik
    Time period covered
    Jan 1, 2021
    Description

    Single cell RNA sequencing (drop-seq) data of forebrain organoids carrying pathogenic MAPT R406W and V337M mutations. Organoids were generated from 5 heterozygous donor lines (two R406W lines and three V337M lines) and respective CRISPR-corrected isogenic controls. Organoids were also generated from one homozygous R406W donor line. Single-cell sequencing was performed at 1, 2, 3, 4, 6 and 8 months of organoid maturation., Single-cell transcriptomes were obtained using drop-seq (Macosko et al., 2015, https://doi.org/10.1016/j.cell.2015.05.002). Counts matrices were generated using the Drop-seq tools package (Macosko et al. 2015), with full details available online (https://github.com/broadinstitute/Drop-seq/files/2425535/Drop-seqAlignmentCookbookv1.2Jan2016.pdf). Briefly, raw reads were converted to BAM files, cell barcodes and UMIs were extracted, and low-quality reads were removed. Adapter sequences and polyA tails were trimmed, and reads were converted to Fastq for STAR alignment (STAR version 2.6). Mapping to human genome (hg19 build) was performed with default settings. Reads mapped to exons were kept and tagged with gene names, beads synthesis errors were corrected, and a digital gene expression matrix was extracted from the aligned library. We extracted data from twice as many cell barcodes as the number of cells targeted (NUM_CORE_BARCODES = 2x # targeted cells). Downstream analysis was performed ..., The package Seurat (https://satijalab.org/seurat) in R is required to read the FB1.seurat file

  17. integration of two scRNA-seq data sets covering 15 human liver donors...

    • zenodo.org
    Updated Jun 5, 2024
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Nicolaas Van Renne; Nicolaas Van Renne (2024). integration of two scRNA-seq data sets covering 15 human liver donors (Ramachandran, 2019 Nature and Nkongolo, 2023 J Clin Invest) [Dataset]. http://doi.org/10.5281/zenodo.11487048
    Explore at:
    Dataset updated
    Jun 5, 2024
    Dataset provided by
    Zenodohttp://zenodo.org/
    Authors
    Nicolaas Van Renne; Nicolaas Van Renne
    License

    Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
    License information was derived automatically

    Description

    rds file for R software, containing a seurat object. Load with after calling Seurat library. https://satijalab.org/seurat/

    Original data matrices with raw readcounts were downloaded from NCBI GEO

  18. f

    Pathways from KEGG enrichment analysis with genes of cluster2 in the heatmap...

    • plos.figshare.com
    xlsx
    Updated Nov 26, 2024
    + more versions
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Rong He; Qiang Zhang; Limei Wang; Yiwen Hu; Yue Qiu; Jia Liu; Dingyun You; Jishuai Cheng; Xue Cao (2024). Pathways from KEGG enrichment analysis with genes of cluster2 in the heatmap for humans (Fig 7C). [Dataset]. http://doi.org/10.1371/journal.pone.0311374.s013
    Explore at:
    xlsxAvailable download formats
    Dataset updated
    Nov 26, 2024
    Dataset provided by
    PLOS ONE
    Authors
    Rong He; Qiang Zhang; Limei Wang; Yiwen Hu; Yue Qiu; Jia Liu; Dingyun You; Jishuai Cheng; Xue Cao
    License

    Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
    License information was derived automatically

    Description

    Pathways from KEGG enrichment analysis with genes of cluster2 in the heatmap for humans (Fig 7C).

  19. Z

    Repository for Single Cell RNA Sequencing Analysis of The EMT6 Dataset

    • data.niaid.nih.gov
    • zenodo.org
    Updated Nov 20, 2023
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Hsu, Jonathan (2023). Repository for Single Cell RNA Sequencing Analysis of The EMT6 Dataset [Dataset]. https://data.niaid.nih.gov/resources?id=zenodo_10011621
    Explore at:
    Dataset updated
    Nov 20, 2023
    Dataset provided by
    Stoop, Allart
    Hsu, Jonathan
    Description

    Table of Contents

    Main Description File Descriptions Linked Files Installation and Instructions

    1. Main Description

    This is the Zenodo repository for the manuscript titled "A TCR β chain-directed antibody-fusion molecule that activates and expands subsets of T cells and promotes antitumor activity.". The code included in the file titled marengo_code_for_paper_jan_2023.R was used to generate the figures from the single-cell RNA sequencing data. The following libraries are required for script execution:

    Seurat scReportoire ggplot2 stringr dplyr ggridges ggrepel ComplexHeatmap

    File Descriptions

    The code can be downloaded and opened in RStudios. The "marengo_code_for_paper_jan_2023.R" contains all the code needed to reproduce the figues in the paper The "Marengo_newID_March242023.rds" file is available at the following address: https://zenodo.org/badge/DOI/10.5281/zenodo.7566113.svg (Zenodo DOI: 10.5281/zenodo.7566113). The "all_res_deg_for_heat_updated_march2023.txt" file contains the unfiltered results from DGE anlaysis, also used to create the heatmap with DGE and volcano plots. The "genes_for_heatmap_fig5F.xlsx" contains the genes included in the heatmap in figure 5F.

    Linked Files

    This repository contains code for the analysis of single cell RNA-seq dataset. The dataset contains raw FASTQ files, as well as, the aligned files that were deposited in GEO. The "Rdata" or "Rds" file was deposited in Zenodo. Provided below are descriptions of the linked datasets:

    Gene Expression Omnibus (GEO) ID: GSE223311(https://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE223311)

    Title: Gene expression profile at single cell level of CD4+ and CD8+ tumor infiltrating lymphocytes (TIL) originating from the EMT6 tumor model from mSTAR1302 treatment. Description: This submission contains the "matrix.mtx", "barcodes.tsv", and "genes.tsv" files for each replicate and condition, corresponding to the aligned files for single cell sequencing data. Submission type: Private. In order to gain access to the repository, you must use a reviewer token (https://www.ncbi.nlm.nih.gov/geo/info/reviewer.html).

    Sequence read archive (SRA) repository ID: SRX19088718 and SRX19088719

    Title: Gene expression profile at single cell level of CD4+ and CD8+ tumor infiltrating lymphocytes (TIL) originating from the EMT6 tumor model from mSTAR1302 treatment. Description: This submission contains the raw sequencing or .fastq.gz files, which are tab delimited text files. Submission type: Private. In order to gain access to the repository, you must use a reviewer token (https://www.ncbi.nlm.nih.gov/geo/info/reviewer.html).

    Zenodo DOI: 10.5281/zenodo.7566113(https://zenodo.org/record/7566113#.ZCcmvC2cbrJ)

    Title: A TCR β chain-directed antibody-fusion molecule that activates and expands subsets of T cells and promotes antitumor activity. Description: This submission contains the "Rdata" or ".Rds" file, which is an R object file. This is a necessary file to use the code. Submission type: Restricted Acess. In order to gain access to the repository, you must contact the author.

    Installation and Instructions

    The code included in this submission requires several essential packages, as listed above. Please follow these instructions for installation:

    Ensure you have R version 4.1.2 or higher for compatibility.

    Although it is not essential, you can use R-Studios (Version 2022.12.0+353 (2022.12.0+353)) for accessing and executing the code.

    1. Download the *"Rdata" or ".Rds" file from Zenodo (https://zenodo.org/record/7566113#.ZCcmvC2cbrJ) (Zenodo DOI: 10.5281/zenodo.7566113).
    2. Open R-Studios (https://www.rstudio.com/tags/rstudio-ide/) or a similar integrated development environment (IDE) for R.
    3. Set your working directory to where the following files are located:

    marengo_code_for_paper_jan_2023.R Install_Packages.R Marengo_newID_March242023.rds genes_for_heatmap_fig5F.xlsx all_res_deg_for_heat_updated_march2023.txt

    You can use the following code to set the working directory in R:

    setwd(directory)

    1. Open the file titled "Install_Packages.R" and execute it in R IDE. This script will attempt to install all the necessary pacakges, and its dependencies in order to set up an environment where the code in "marengo_code_for_paper_jan_2023.R" can be executed.
    2. Once the "Install_Packages.R" script has been successfully executed, re-start R-Studios or your IDE of choice.
    3. Open the file "marengo_code_for_paper_jan_2023.R" file in R-studios or your IDE of choice.
    4. Execute commands in the file titled "marengo_code_for_paper_jan_2023.R" in R-Studios or your IDE of choice to generate the plots.
  20. o

    Repository for the single cell RNA sequencing data analysis for the human...

    • explore.openaire.eu
    Updated Aug 26, 2023
    Share
    FacebookFacebook
    TwitterTwitter
    Email
    Click to copy link
    Link copied
    Close
    Cite
    Jonathan; Andrew; Pierre; Allart; Adrian (2023). Repository for the single cell RNA sequencing data analysis for the human manuscript. [Dataset]. http://doi.org/10.5281/zenodo.8286134
    Explore at:
    Dataset updated
    Aug 26, 2023
    Authors
    Jonathan; Andrew; Pierre; Allart; Adrian
    Description

    This is the GitHub repository for the single cell RNA sequencing data analysis for the human manuscript. The following essential libraries are required for script execution: Seurat scReportoire ggplot2 dplyr ggridges ggrepel ComplexHeatmap Linked File: -------------------------------------- This repository contains code for the analysis of single cell RNA-seq dataset. The dataset contains raw FASTQ files, as well as, the aligned files that were deposited in GEO. Provided below are descriptions of the linked datasets: 1. Gene Expression Omnibus (GEO) ID: GSE229626 - Title: Gene expression profile at single cell level of human T cells stimulated via antibodies against the T Cell Receptor (TCR) - Description: This submission contains the matrix.mtx, barcodes.tsv, and genes.tsv files for each replicate and condition, corresponding to the aligned files for single cell sequencing data. - Submission type: Private. In order to gain access to the repository, you must use a "reviewer token"(https://www.ncbi.nlm.nih.gov/geo/info/reviewer.html). 2. Sequence read archive (SRA) repository - Title: Gene expression profile at single cell level of human T cells stimulated via antibodies against the T Cell Receptor (TCR) - Description: This submission contains the "raw sequencing" or .fastq.gz files, which are tab delimited text files. - Submission type: Private. In order to gain access to the repository, you must use a "reviewer token" (https://www.ncbi.nlm.nih.gov/geo/info/reviewer.html). Please note that since the GSE submission is private, the raw data deposited at SRA may not be accessible until the embargo on GSE229626 has been lifted. Installation and Instructions -------------------------------------- The code included in this submission requires several essential packages, as listed above. Please follow these instructions for installation: > Ensure you have R version 4.1.2 or higher for compatibility. > Although it is not essential, you can use R-Studios (Version 2022.12.0+353 (2022.12.0+353)) for accessing and executing the code. The following code can be used to set working directory in R: > setwd(directory) Steps: 1. Download the "Human_code_April2023.R" and "Install_Packages.R" R scripts, and the processed data from GSE229626. 2. Open "R-Studios"(https://www.rstudio.com/tags/rstudio-ide/) or a similar integrated development environment (IDE) for R. 3. Set your working directory to where the following files are located: - Human_code_April2023.R - Install_Packages.R 4. Open the file titled Install_Packages.R and execute it in R IDE. This script will attempt to install all the necessary pacakges, and its dependencies. 5. Open the Human_code_April2023.R R script and execute commands as necessary.

Share
FacebookFacebook
TwitterTwitter
Email
Click to copy link
Link copied
Close
Cite
Yunshun Chen; Gordon Smyth (2023). Data, R code and output Seurat Objects for single cell RNA-seq analysis of human breast tissues [Dataset]. http://doi.org/10.6084/m9.figshare.17058077.v1
Organization logoOrganization logo

Data, R code and output Seurat Objects for single cell RNA-seq analysis of human breast tissues

Explore at:
application/gzipAvailable download formats
Dataset updated
May 31, 2023
Dataset provided by
Figsharehttp://figshare.com/
figshare
Authors
Yunshun Chen; Gordon Smyth
License

Attribution 4.0 (CC BY 4.0)https://creativecommons.org/licenses/by/4.0/
License information was derived automatically

Description

This dataset contains all the Seurat objects that were used for generating all the figures in Pal et al. 2021 (https://doi.org/10.15252/embj.2020107333). All the Seurat objects were created under R v3.6.1 using the Seurat package v3.1.1. The detailed information of each object is listed in a table in Chen et al. 2021.

Search
Clear search
Close search
Google apps
Main menu