Abstract
Breast cancer is a common and highly heterogeneous disease. Understanding cellular diversity in the mammary gland and its surrounding micro-environment across different states can provide insight into cancer development in the human breast. Recently, we published a large-scale single-cell RNA expression atlas of the human breast spanning normal, preneoplastic and tumorigenic states. Single-cell expression profiles of nearly 430,000 cells were obtained from 69 distinct surgical tissue specimens from 55 patients. This article extends the study by providing quality filtering thresholds, downstream processed R data objects, complete cell annotation and R code to reproduce all the analyses. Data quality assessment measures are presented and details are provided for all the bioinformatic analyses that produced results described in the study.
Subject terms: Breast cancer, Data integration, Statistical methods
Measurement(s) | gene expression |
Technology Type(s) | 10x sequencing protocol • mRNA Sequencing |
Factor Type(s) | Gender • Menopause status • Parity • Cancer type • Cell population |
Sample Characteristic - Organism | Homo sapiens |
Background & Summary
Breast cancer is the most commonly diagnosed cancer and the leading cause of cancer death in women1. It is a very heterogeneous disease at the molecular level2. Different breast cancer subtypes can be characterized on the basis of expression profiles of markers such as estrogen receptor (ER), progesterone receptor (PgR), and human epidermal growth factor receptor 2 (HER2)3. The development of certain cancer subclasses is also known to be associated with mutations such as BRCA14. Recently, we and colleagues constructed a large-scale single-cell RNA expression atlas of the human breast spanning normal, preneoplastic and tumorigenic states (subsequently referred to as the ScBrAtlas)5. Single-cell expression profiles of nearly 430,000 cells were obtained from 69 distinct surgical tissue specimens from 55 patients (Fig. 1). This article extends the ScBrAtlas by providing downstream processed R data objects, complete cell annotation and R code to reproduce all the analyses.
The ScBrAtlas spanned several stages of breast cancer genesis. First, reduction mammoplasties were obtained from women with no family history of breast cancer to explore cellular diversity in normal breast epithelia as well as complexity within the normal breast ductal micro-environment. Three major epithelial cell populations revealed in literature6: basal, luminal progenitor (LP), and mature luminal (ML), were confirmed by the bulk RNA-seq signatures for sorted epithelial populations as well as the cell clustering of the integrated single cell transcriptomic data on normal breast epithelia. Similar cell type composition within the normal epithelium was observed across multiple healthy donors with different hormonal status (pre- and post-menopausal). For the immune and stromal micro-environment of normal breast tissue, integration analysis and the pseudo-bulk differential expression analysis identified different cell clusters including fibroblasts, endothelial cells (vascular and lymphatic), pericytes, myeloid, and lymphoid cells. Differential abundance analysis revealed that fibroblasts are more abundant whereas vascular endothelial cells are less abundant in post-menopausal tissue compared to pre-menopausal tissue5.
Next, breast tissue from BRCA1 mutation carriers was obtained for investigating cellular changes in precancerous state. Overall, the differences of stromal and immune subsets between normal and BRCA1+/− preneoplastic tissue were not significant, nor was the proportions of different cell clusters. However, extensive changes in the tissue micro-environment were observed between the preneoplastic and the neoplastic states in BRCA1 mutation carriers5.
Finally, ER+, HER2+ and triple negative breast cancer (TNBC) tumors were obtained from treatment-naive patients for exploring the degree of heterogeneity within the cancer cell compartment and its micro-environment across different tumor subtypes. Extensive inter-patient heterogeneity was revealed by single cell integration analyses across all cancer subtypes. Within the tumor populations, a discrete cluster of cycling MKI67+ tumor cells were observed for all three major breast cancer subtypes. Within the tumor micro-environment, different immune landscapes were observed in different cancer subtypes. Both TNBC and HER2 featured a proliferative CD8+ T-cell cluster, whereas ER+ tumors primarily comprised cycling TAMs. In addition, matched pairs of ER+ tumors and involved lymph nodes were profiled for examining the relationship between primary breast tumors and malignant cells that seed lymph nodes. Clonal selection and expansion were observed in some patients, whereas mass migration of cells from the primary tumor to the LN was observed in some other patients5.
The ScBrAtlas provides a valuable resource for understanding cellular diversity and cancer genesis in human breast. The examination and exploration of the single cell data presented in this study required large-scale bioinformatics analyses for multiple groupings of the original data. While genewise read counts were previously made publicly available for all 421,761 individual cells7, downstream results after quality filtering, data integration and cell clustering were not provided.
In this report we describe the bioinformatics analysis used in the ScBrAtlas in greater detail. We provide a complete description of the quality control filters used to select 341,874 cells for downstream analyses. The technical quality of both the 10X single-cell transcriptomic data sets and the bulk RNA-seq reference data set is assessed to demonstrate the reliability of the data. We provide downstream R data objects corresponding to each data integration and cell clustering presented in the ScBrAtlas, together with R code to reproduce the data objects. Crucially, the data objects provided here include cell barcodes by which each individual cell can be tracked through all the analyses. We also provide detailed information allowing the copy number variation analyses to be mapped back to individual samples and cell clustered, thus providing a way to distinguish putative malignant cancer cells from normal epithelial cells in the cancer tumors. All the resources and the detailed information can be easily accessed and utilized by researchers for further exploration and clinical validation, which may lead to discoveries of novel approaches for personalized breast cancer treatment in the future.
Methods
Human Samples
This article is a companion to the ScBrAtlas study and ethics approval regarding human samples is as stated in that article5. Human breast tissues were obtained from consenting patients through the Royal Melbourne Hospital Tissue Bank, the Victorian Cancer Biobank and kConFab with relevant institutional review board approval. Human Ethics approval was obtained from the Walter and Eliza Hall Institute Human Research Ethics Committee.
Read alignment and count quantification
Single-cell RNA-seq expression profiles of 69 samples from 55 patients were generated using the 10x Genomics Chromium platform and an Illumina NextSeq 500 sequencer (Fig. 1a, Supplementary Table 1). Genewise read counts were produced for all samples using Cell Ranger v3.0.2 (https://support.10xgenomics.com). Specifically, the Illumina base call files (BCLs) were demultiplexed into FASTQ files by “cellranger mkfastq” then genewise read counts were obtained using “cellranger count” with the Cell Ranger human GRCh38 reference v3.0.0. Default settings were used for all parameters apart from file locations and memory usage. For each biological sample, results were taken from the Cell Ranger output directory “outs/filtered_feature_bc_matrix”. The output for each sample consists of three files: the count matrix in matrix market mtx.gz format, the cellular barcodes (barcodes.tsv.gz) and the gene identifiers (features.tsv.gz). All samples share the same gene identifiers but the count matrix and barcode files are sample-specific (Supplementary Table 1). The files provide results for a total of 421,761 cells across the 69 samples (Supplementary Table 2). All cells included in the Cell Ranger output have least 500 reads successfully assigned to genes. The Cell Ranger output files were deposited as GEO series GSE1615297 and were used for downstream bioinformatics analyses.
Quality control and cell filtering
All samples were first checked using marker genes to confirm the presence of epithelial cells and the absence of significant stromal cell contamination. Then an average of 15% of cells were filtered from each sample based on (i) the total number of mapped reads for that cell (library size), (ii) the number of genes detected and (iii) the proportion of reads mapping to the mitochondria8 (Fig. 2). A lower bound of 500 was generally applied to the number of detected genes for each cell, although this was reduced to 400 or 300 for a small number of samples with low read coverage. Upper bounds were applied to the number of detected genes and to library size to remove potential doublets. Thresholds were chosen for each sample by plotting genes detected versus library size and choosing thresholds that excluded outliers but kept the main body of cells.
For most samples, an upper limit of 0.2 was placed on the mitochondrial proportion with 80–100% of cells below this threshold. For one high quality sample with very low mitochondrial proportions the threshold was tightened to 0.1. For a few samples with higher mitochondrial proportions, the mitochondrial threshold was loosened to 0.25, 0.3 or 0.4 in order to keep the majority of the cells. These samples were considered of lesser quality but not so poor as to be excluded from the analysis.
The threshold values used for these QC metrics are shown in Supplementary Table 2 and are also supplied in machine-readable form as part of the data submission9. A total of 341,874 cells remained after quality filtering for downstream analysis.
Single-cell RNA-seq integration analysis
The samples included breast tissues from normal healthy donors, BRCA1 mutation carriers and patients diagnosed with different types of breast cancer (triple negative, ER+ and HER2+). Matching pairs of tumor and lymph node (LN) samples, as well as tumor samples from male patients, were also included. The single-cell analysis strategy involved grouping together comparable samples, integrating the profiles, then clustering cells into putative cell types. A total of 16 different sample-groups were integrated (Fig. 1b). Some samples were involved in more than one integration, for example the pre-neoplastic samples with BRCA1 mutations were integrated first with the normal samples and later with the BRCA1 triple negative (TN) tumor samples. For some sample-groups analyses, subsets of cells were extracted, re-integrated and re-clustered. The total number of cell cluster analyses is shown in Table 1.
Table 1.
Label | Tissue Sample Type | Cell Family | Figure |
---|---|---|---|
NormEpi | Normal breast | epithelial cells | EV1C |
NormEpiSub | Normal breast | epithelial cells without stroma | 1E |
NormTotal | Normal breast | total cells | 2B |
NormTotalSub | Normal breast | non-epithelial | 2D |
NormTotalFib | Normal breast | fibroblast cells | 3D |
NormB1Total | Normal and BRCA1 preneoplastic | total cells | 4B |
NormB1TotalSub | Normal and BRCA1 preneoplastic | non-epithelial | 4C |
BRCA1Tum | BRCA1 preneoplastic and BRCA1 TNBC | total cells | 4E |
BRCA1TumSub | BRCA1 preneoplastic and BRCA1 TNBC | non-epithelial | 5A |
TNBC | TNBC | total cells | 6A |
HER2 | HER2+ breast tumor | total cells | 6B |
ERTotal | ER+ breast tumor | total cells | 6C |
ERTotalTum | ER+ breast tumor | epithelial cells | 6E |
PairedER | Two ER+ breast tumors from patient 0029 | total cells | 6H |
TNBCSub | TNBC | non-epithelial | 7A |
HER2Sub | HER2+ breast tumor | non-epithelial | 7B |
ERTotalSub | ER+ breast tumor | non-epithelial | 7C |
TNBCTum | TNBC | epithelial cells | EV3B (top) |
HER2Tum | HER2+ breast tumor | epithelial cells | EV3B (bottom) |
TNBCTC | TNBC | T-cells | EV4A (left) |
HER2TC | HER2+ breast tumor | T-cells | EV4A (middle) |
ERTotalTC | ER+ breast tumor | T-cells | EV4A (right) |
Male | ER+ breast tumors from male patients | total cells | EV5A |
TumLN | ER+ breast tumor & lymph-node pairs from 7 patients | total cells | 9A |
Each row corresponds to one integration and cell clustering, except for TumLN, where one clustering was done for each of the 7 patients. Columns indicate the group of samples integrated, the cell subset clustered and the figure reference in the original ScBrAtlas study5.
Samples were integrated using the Seurat anchor-based integration method10. To perform dimensionality reduction, the first 30 principal component were computed and used for the cell clustering and t-distributed stochastic neighbor embedding (t-SNE) visualization11. The default Louvain clustering algorithm12 was used for cell cluster identification. Cluster resolutions were typically set to values around 0.1, lower than the Seurat default, in order to ensure conservative and reproducible clusters. The only exception was Figure EV4A where much higher resolutions were used in order to distinguish subsets of T cells5.
We provide here the Seurat data objects containing each of the cluster analyses as R data files (Table 2). The R data objects contain cell cluster details for each cell. The R code by which each R object was constructed is also provided (Table 2).
Table 2.
Label | Data filename | Code filename |
---|---|---|
NormEpi | SeuratObject_NormEpi.rds | NormEpi.R |
NormEpiSub | SeuratObject_NormEpiSub.rds | NormEpi.R |
NormTotal | SeuratObject_NormTotal.rds | NormTotal.R |
NormTotalSub | SeuratObject_NormTotalSub.rds | NormTotal.R |
NormTotalFib | SeuratObject_NormTotalFib.rds | NormTotal.R |
NormB1Total | SeuratObject_NormB1Total.rds | NormBRCA1.R |
NormB1TotalSub | SeuratObject_NormB1TotalSub.rds | NormBRCA1.R |
BRCA1Tum | SeuratObject_BRCA1Tum.rds | BRCA1Tum.R |
BRCA1TumSub | SeuratObject_BRCA1TumSub.rds | BRCA1Tum.R |
TNBC | SeuratObject_TNBC.rds | TNBC.R |
TNBCSub | SeuratObject_TNBCSub.rds | TNBC.R |
TNBCTC | SeuratObject_TNBCTC.rds | TNBC.R |
TNBCTum | SeuratObject_TNBCTum.rds | TNBC.R |
HER2 | SeuratObject_HER2.rds | HER2.R |
HER2Sub | SeuratObject_HER2Sub.rds | HER2.R |
HER2TC | SeuratObject_HER2TC.rds | HER2.R |
HER2Tum | SeuratObject_HER2Tum.rds | HER2.R |
ERTotal | SeuratObject_ERTotal.rds | ER.R |
ERTotalSub | SeuratObject_ERTotalSub.rds | ER.R |
ERTotalTC | SeuratObject_ERTotalTC.rds | ER.R |
ERtotalTum | SeuratObject_ERTotalTum.rds | ER.R |
Male | SeuratObject_Male.rds | Male.R |
PairedER | SeuratObject_PairedER.rds | PairedER.R |
TumLN | SeuratObject_TumLN.rds | TumLN.R |
Data files are in RDS format. Each data file contains one Seurat object except for TumLN, which contains a list of 7 Seurat objects. Each Seurat data object provides cell cluster identities and associated information for the corresponding cell cluster analysis. Code files contain the R code used to produce the corresponding Seurat objects.
Differential expression and pathway analysis
Differential expression analyses were performed to detect marker genes for different cell clusters. In order to account for the biological variation between different patients, a pseudo-bulk approach was used in most cases where read counts from all cells under the same cluster-sample combination were summed together to form pseudo-bulk samples. The edgeR’s quasi-likelihood pipeline was used for pseudo-bulk differential expression analysis, where the baseline differences between patients were incorporated into the linear model13. The Seurat’s FindMarkers function was applied where pseudo-bulk samples were not satisfactory due to low cell numbers or imbalanced cluster-sample combination. KEGG pathway analyses were performed using the kegga function of the limma package14.
Data visualization
Ternary plot visualization was performed as previously described15. Ternary plots position cells according to the proportion of basal, LP- or ML-positive signature genes expressed by that cell and were generated using the vcd package16. The t-SNE visualization for all the integration analyses were generated using the RunTSNE function in Seurat with a random seed of 2018 for reproducibility. Diffusion plots were generated using the destiny package17. Multi-dimensional scaling (MDS) plots were created with edgeR’s plotMDS function. Log2-CPM values for each gene across cells were calculated using edgeR’s cpm function with a prior count of 1. Heat maps were generated using the pheatmap package. Log2-CPM values were standardized to have mean 0 and standard deviation 1 for each gene before producing the heat maps, after which genes and cells were clustered by the Ward’s minimum variance method18.
Bulk RNA-seq data and differential expression analysis
RNA-seq experiments were performed to obtain signature genes of basal, luminal progenitor (LP), mature luminal (ML) and stromal cell populations. Epithelial cells for basal, LP, and ML populations were sorted from eight independent patients and stroma from five patients. For one particular patient, samples were collected from both left and right breast for each of the four cell populations. For another patient, the ML cell population was collected twice. The complete RNA-seq data contains 9 basal, 9 LP, 10 ML and 6 stroma samples. RNA-seq libraries were prepared using Illumina’s TruSeq protocol and were sequenced on an Illumina NextSeq 500.
Reads were aligned to the hg38 genome using Rsubread v1.5.319. Gene counts were quantified by Entrez Gene IDs using featureCounts and Rsubread’s built-in annotation20. Gene symbols were provided by NCBI gene annotation dated 29 September 2017. Immunoglobulin genes as well as obsolete Entrez Ids were discarded. Genes with count-per-million above 0.3 in at least 3 samples were kept in the analysis. TMM normalization was performed to account for the compositional biases between samples.
Differential expression analysis was performed using limma-voom21. Patients were treated as random effects and the intra-patient correlation was estimated by the duplicateCorrelation function in limma. Pairwise comparisons between the four cell populations were performed using TREAT with a fold change threshold of 1.522. An FDR cut-off of 0.05 was applied for each comparison. Genes were considered as signature genes for a particular cell type if they were upregulated in that cell type in all the pairwise comparisons. The analysis yielded 515, 323, 765, and 1094 signature genes for basal, LP, ML, and stroma, respectively. In this submission we provide gene symbols of the signature genes as an R data file and R code to reproduce the bulk RNA-seq analysis9
Differential abundance analysis
Differential abundance analyses were performed to examine the differences in cell cluster frequencies between pre-menopause and post-menopause groups in normal breast tissue micro-environment. Quasi-multinomial and quasi-binomial generalized linear models were used in order to account for the inter-patient variability. The numbers of cells under all the clusters from each individual donor were counted and used as the response variable in the model. The glm function of the stats package was used to fit the cell numbers against cell clusters, donors, plus a cluster-menopausal interaction term. The quasi-Poisson family was used in the glm function.
A quasi-multinomial F-test was performed to test for differences in cluster frequencies across all the clusters between pre- and post-menopausal samples, which yielded a p-value of 0.007. To test for cluster frequency differences for each individual cluster, we compared the cell numbers of that cluster with the aggregated cell numbers of all the other clusters across all the donors. Quasi-binomial generalized linear models were fitted and quasi-binomial F-tests were performed for each cluster separately. The p-values are 0.040 and 0.032 for cluster 1 and cluster 2, respectively, indicating these two clusters have significantly different sizes between pre- and post-menopause conditions after accounting for inter-patient variability. Sizes are not significantly different for other clusters. The R code to reproduce the differential abundance analysis is provided in the files NormEpi.R and NormTotal.R (Table 2).
Copy number variation analysis
Copy number variation (CNV) analysis was performed using inferCNV of the Trinity CTAT Project (https://github.com/broadinstitute/inferCNV), which compares gene expression intensity across genomic locations in the tumor or lymph-node samples with those in a normal reference sample. The single-cell RNA expression profile of a normal breast total cells sample (N-0372-total) was adopted as a reference for all the CNV analyses presented in the ScBrAtlas study. The results of each CNV analysis were visualized in a heatmap, which showed the relative expression intensities of the tumor samples with respect to the normal reference. For ease of visualization, cells from the same patient within the same cluster were grouped into a single column block, and only the blocks containing more than 100 cells were used in the heatmap. All the column blocks were assigned an equal width in each of the heatmap. The column block annotation of all the CNV heatmaps in this study is available as part of the Figshare deposition, indicating which clusters in which samples were classified as normal or tumor9.
Data Records
Cell Ranger genewise read counts for the 69 scRNA-seq profiles, prior to quality filtering, are available as GEO series GSE1615297. Quality filtering thresholds, downstream R data objects storing cell cluster identities and associated R code are available from Figshare9. Specific files available from Figshare are listed in Table 2.
The bulk RNA-seq genewise read counts are available as GEO series GSE16189223. The cell-type signature genes generated from the bulk RNA-seq and associated R code are available from Figshare9.
Technical Validation
Technical quality of the 10X single-cell transcriptomic datasets was assessed by examining the number of mapped reads and the number of detected genes (genes with at least one read count mapped to it) for all cells across all the samples (Fig. 2a,b).
Quality control was performed to remove cells of low quality. Cells with a high proportion of mitochondrial reads or a low number of detected genes were removed. For each sample, an upper limit of library size was also used in combination with an upper limit of number of detected genes to remove potential multiplets. The proportion of cells retained after filtering is 82.2% across all 69 samples, indicating good data quality (Fig. 2c).
Technical quality of the bulk RNA-seq data was assessed using MDS and biological coefficient of variation (BCV) plots (Fig. 3).
Usage Notes
The code provided may be run using the free R programming environment with Bioconductor and Seurat R software packages https://www.r-project.org. The RDS files may be read using R’s readRDS() function. The Seurat objects allow readers to use and extend the results of the major analyses conducted as part of the ScBrAtlas study. Cell barcodes and Seurat cell clustering information are stored in the meta.data component of each Seurat object.
Supplementary information
Acknowledgements
This work was supported by the Chan Zuckerberg Initiative (EOSS4 grant number 2021–237445), the National Breast Cancer Foundation (NBCF, IIRS-20–022), Australian National Health and Medical Research Council (NHMRC) grants (#1054618, 1100807,1113133, 1153049); NHMRC IRIISS; the Victorian State Government Operational Infrastructure Support; the Australian Cancer Research Foundation and the Ian Potter Foundation. G.J.L., G.K.S. and J.E.V. were supported by NHMRC Fellowships (G.J.L. #1078730 and 1175960; G.K.S. #1058892; J.E.V. #1037230 and 1102742); Y.C was supported by Medical Research Future Fund (MRFF) Investigator Grant (#1176199).
Author contributions
Y.C. and G.K.S. performed bioinformatic analyses, deposited analysis code and data objects, and wrote the article; B.P., J.E.V. and G.J.L. designed the study and collected data. All authors reviewed the manuscript.
Code availability
The R code files provided on Figshare contain complete the analyses of the ScBrAtlas study9 (Table 2). Code files are also available from the GitHub repository https://github.com/yunshun/HumanBreast10X. All the bioinformatics analyses were performed in R 3.6.1 on x86_64-pc-linux-gnu (64-bit) platform, running under CentOS Linux 7. The following software packages were used for the analyses: Seurat v3.1.1, limma v3.40.6, edgeR v3.26.8, pheatmap v1.0.12, ggplot2 v3.2.1, org.Hs.eg.db v3.8.2 and vcd v1.4-5.
Competing interests
The authors declare no competing interests.
Footnotes
Publisher’s note Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.
Supplementary information
The online version contains supplementary material available at 10.1038/s41597-022-01236-2.
References
- 1.Bray F, et al. Global cancer statistics 2018: GLOBOCAN estimates of incidence and mortality worldwide for 36 cancers in 185 countries. CA: A Cancer Journal for Clinicians. 2018;68:394–424. doi: 10.3322/caac.21492. [DOI] [PubMed] [Google Scholar]
- 2.Visvader JE. Keeping abreast of the mammary epithelial hierarchy and breast tumorigenesis. Genes & Development. 2009;23:2563–2577. doi: 10.1101/gad.1849509. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3.Sotiriou C, et al. Breast cancer classification and prognosis based on gene expression profiles from a population-based study. Proceedings of the National Academy of Sciences. 2003;100:10393–10398. doi: 10.1073/pnas.1732912100. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.Turner NC, Reis-Filho JS. Basal-like breast cancer and the BRCA1 phenotype. Oncogene. 2006;25:5846–5853. doi: 10.1038/sj.onc.1209876. [DOI] [PubMed] [Google Scholar]
- 5.Pal B, et al. A single-cell RNA expression atlas of normal, preneoplastic and tumorigenic states in the human breast. EMBO Journal. 2021;40:e107333. doi: 10.15252/embj.2020107333. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6.Lim E, et al. Aberrant luminal progenitors as the candidate target population for basal tumor development in BRCA1 mutation carriers. Nature Medicine. 2009;15:907–913. doi: 10.1038/nm.2000. [DOI] [PubMed] [Google Scholar]
- 7.Smyth GK, Chen Y, Visvader JE. 2021. scRNA-seq profiling of breast cancer tumors, BRCA1 mutant pre-neoplastic mammary gland cells and normal mammary gland cells. Gene Expression Omnibus. GSE161529
- 8.Ilicic T, et al. Classification of low quality cells from single-cell RNA-seq data. Genome Biology. 2016;17:1–15. doi: 10.1186/s13059-016-0888-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Chen Y, Smyth GK. 2021. Data, R code and output Seurat objects for single cell RNA-seq analysis of human breast tissues. figshare. [DOI]
- 10.Stuart T, et al. Comprehensive integration of single-cell data. Cell. 2019;177:1888–1902. doi: 10.1016/j.cell.2019.05.031. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Van der Maaten, L. & Hinton, G. Visualizing data using t-SNE. Journal of Machine Learning Research9 (2008).
- 12.Blondel VD, Guillaume J-L, Lambiotte R, Lefebvre E. Fast unfolding of communities in large networks. Journal of Statistical Mechanics: Theory and Experiment. 2008;2008:P10008. doi: 10.1088/1742-5468/2008/10/P10008. [DOI] [Google Scholar]
- 13.Chen Y, Lun ATL, Smyth GK. From reads to genes to pathways: differential expression analysis of RNA-seq experiments using Rsubread and the edgeR quasi-likelihood pipeline. F1000Research. 2016;5:1438. doi: 10.12688/f1000research.8987.1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Ritchie ME, et al. limma powers differential expression analyses for RNA-sequencing and microarray studies. Nucleic Acids Research. 2015;43:e47. doi: 10.1093/nar/gkv007. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Pal B, et al. Construction of developmental lineage relationships in the mouse mammary gland by single-cell RNA profiling. Nature Communications. 2017;8:1–14. doi: 10.1038/s41467-017-01560-x. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Meyer, D., Zeileis, A. & Hornik, K. vcd: Visualizing categorical data. R package available from https://cran.r-project.org/package=vcd (2008).
- 17.Angerer P, et al. destiny: diffusion maps for large-scale single-cell data in R. Bioinformatics. 2016;32:1241–1243. doi: 10.1093/bioinformatics/btv715. [DOI] [PubMed] [Google Scholar]
- 18.Ward JH., Jr Hierarchical grouping to optimize an objective function. Journal of the American Statistical Association. 1963;58:236–244. doi: 10.1080/01621459.1963.10500845. [DOI] [Google Scholar]
- 19.Liao Y, Smyth GK, Shi W. The R package Rsubread is easier, faster, cheaper and better for alignment and quantification of RNA sequencing reads. Nucleic Acids Research. 2019;47:e47. doi: 10.1093/nar/gkz114. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20.Liao Y, Smyth GK, Shi W. featureCounts: an efficient general-purpose read summarization program. Bioinformatics. 2014;30:923–930. doi: 10.1093/bioinformatics/btt656. [DOI] [PubMed] [Google Scholar]
- 21.Law CW, Chen Y, Shi W, Smyth GK. Voom: precision weights unlock linear model analysis tools for RNA-seq read counts. Genome Biology. 2014;15:R29. doi: 10.1186/gb-2014-15-2-r29. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22.McCarthy DJ, Smyth GK. Testing significance relative to a fold-change threshold is a TREAT. Bioinformatics. 2009;25:765–771. doi: 10.1093/bioinformatics/btp053. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.Smyth GK, Chen Y, Pal B, Visvader JE. 2021. RNA-seq expression profiling of stromal and epithelial cell subpopulations from human breast tissue. Gene Expression Omnibus. GSE161892
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Data Citations
- Smyth GK, Chen Y, Visvader JE. 2021. scRNA-seq profiling of breast cancer tumors, BRCA1 mutant pre-neoplastic mammary gland cells and normal mammary gland cells. Gene Expression Omnibus. GSE161529
- Chen Y, Smyth GK. 2021. Data, R code and output Seurat objects for single cell RNA-seq analysis of human breast tissues. figshare. [DOI]
- Smyth GK, Chen Y, Pal B, Visvader JE. 2021. RNA-seq expression profiling of stromal and epithelial cell subpopulations from human breast tissue. Gene Expression Omnibus. GSE161892
Supplementary Materials
Data Availability Statement
The R code files provided on Figshare contain complete the analyses of the ScBrAtlas study9 (Table 2). Code files are also available from the GitHub repository https://github.com/yunshun/HumanBreast10X. All the bioinformatics analyses were performed in R 3.6.1 on x86_64-pc-linux-gnu (64-bit) platform, running under CentOS Linux 7. The following software packages were used for the analyses: Seurat v3.1.1, limma v3.40.6, edgeR v3.26.8, pheatmap v1.0.12, ggplot2 v3.2.1, org.Hs.eg.db v3.8.2 and vcd v1.4-5.