Bethesda, MD
Repositories
Trans NIH Facility
The CHTN is a unique NCI-supported resource that provides human tissues and fluids from routine procedures to investigators who utilize human biospecimens in their research. Unlike tissue banks, the CHTN works prospectively with each investigator Read More...
Web Page
Bioinformatics
If we want to retain only the samples included in our diversity analyses, we can use qiime feature-table filter-samples to drop samples with read depths less than 10,000. qiime feature-table filter-samples \ --i-table filtered-table-3.qza \ --p-min-frequency 10000 \ --o-filtered-table Read More...
Bethesda, MD
Collaborative
Repositories
The National Clinical Trials Network Biospecimen Banks (NCTN) receive, store, and distribute human cancer biospecimens collected on NCTN clinical trials. NCTN Biobanks provide cancer researchers with quality, well-annotated biospecimens and associated clinical information. The NCTN Read More...
ROCKVILLE, MD
Repositories
Trans NIH Facility
The Specimen Resource Locator (SRL) is a biospecimen resource database designed to help researchers locate resources that may have the samples needed for their investigational use. This publicly searchable database includes information about biospecimen banks Read More...
Web Page
Bioinformatics
By using the metacharacter asterisk "*" we can run feature counts on all the HBR and UHR samples in one command line. featureCounts -a refs/ERCC92.gtf -g gene_name -o counts.txt bam/ Read More...
Web Page
Bioinformatics
By using the metacharacter asterisk "*" we can run feature counts on all the HBR and UHR samples in one command line. featureCounts -a refs/ERCC92.gtf -g gene_name -o counts.txt bam/ Read More...
Web Page
Bioinformatics
By using the metacharacter asterisk "*" we can run feature counts on all the HBR and UHR samples in one command line. featureCounts -a refs/ERCC92.gtf -g gene_name -o counts.txt bam/ Read More...
Web Page
Bioinformatics
This page contains content directly from The Biostar Handbook . Always remember to start the bioinformatics environment. conda activate bioinfo Pseudoalignment-based methods identify locations in the genome using patterns rather than via alignment type algorithms. It Read More...
Web Page
Bioinformatics
This page contains content directly from The Biostar Handbook . Always remember to start the bioinformatics environment. conda activate bioinfo Pseudoalignment-based methods identify locations in the genome using patterns rather than via alignment type algorithms. It Read More...
Web Page
Bioinformatics
Notice that the column names each begin with a number (e.g., 1_MB231_RNA1). Place an "S" at the beginning of each sample name using rename_with() , which is similar to rename() , but Read More...
Web Page
Bioinformatics
Globus (https://hpc.nih.gov/storage/globus.html) HPCDME BOX OneDrive (s)FTP Network Drives Flash Drives
Web Page
Bioinformatics
The goal of quality control is to keep only high quality cells (i.e., remove low quality cells (dead or dying cells), cell-free RNA, or doublets). Low quality cells will impact downstream analyses. Take care Read More...
Web Page
Bioinformatics
Frequency based filtering, contingency based filtering, metadata based filtering qiime feature-table filter-samples Filter samples based on total number of sequences (e.g., --p-min-frequency 1000 ) Filter samples with a minimal number of features (e.g., --p-min-features 10 ) Metadata Read More...
Web Page
Bioinformatics
We are going to eliminate some samples based on the timing of collection. We are interested in only the samples collected between ten days prior to their hematopoietic cell transplantation and seventy days post transplantation. Read More...
Web Page
Bioinformatics
If interested in highly prevalent taxa, you could use qiime feature-table core-features , which identifies "features observed in a user-defined fraction of the samples." By default, this will return features observed in at least 50% Read More...
Web Page
Employing spatial biology techniques enables acquisition of transcript and protein data from intact tissue sections, and in turn, spatial distribution information and cellular interaction patterns are revealed.
Web Page
Employing spatial biology techniques enables acquisition of transcript and protein data from intact tissue sections, and in turn, spatial distribution information and cellular interaction patterns are revealed.
Bethesda, MD
Collaborative
Repositories
The National Cancer Institute (NCI) is developing a national repository of Patient-Derived Models (PDMs) comprised of patient-derived xenografts (PDXs), patient-derived organoids (PDOrg), and in vitro patient-derived tumor cell cultures (PDCs) and cancer-associated fibroblasts (CAFs). These Read More...
Web Page
Bioinformatics
Regarding computational requirements, rule of thumb is to keep it at 8 samples or less when running on a laptop. You may be able to stretch it to 10 samples, but any more than that strains the Read More...
Web Page
Bioinformatics
Once we have read in the matrices, the next step is to create a Seurat object. The Seurat object will be used to store the raw count matrices, sample information, and processed data (normalized counts, Read More...
Web Page
Bioinformatics
To look at how these metrics correlate, we can use FeatureScatter() , which can be used to visualize feature-feature relationships and also be applied to other data stored in our Seurat object (e.g., metadata columns, Read More...
Web Page
Bioinformatics
Because of the different layers, you will need to break down the object to apply different thresholds by group or sample. The easiest way to do this is to work with the metadata and use Read More...
Web Page
Bioinformatics
The general experimental design was as follows: WT vs DKO mice at two time points, 0 and 6 days. At day 0, cells were in a preadipocyte state, while at day 6 they had differentiated into adipocytes. Each time Read More...
Web Page
Bioinformatics
Rarefaction is the process of subsampling reads without replacement to a defined sequencing depth, thereby creating a standardized library size across samples. Any sample with a total read count less than the defined sequencing depth Read More...
Web Page
Bioinformatics
A rarefaction curve plot[s] the number of counts sampled (rarefaction depth) vs. the expected value of species diversity. --- Weiss et al. 2017 Let's take a look at an alpha rarefaction curve . Demo plot Read More...
Web Page
Bioinformatics
Can we use microbial community composition to predict a condition? For example, maybe we are interested in whether microbial community composition can predict a cancer state from a non-cancer state. In QIIME 2, we could use Read More...
Web Page
Bioinformatics
Let's use our practice data set to run ANCOM. Step 1: Filter out low abundance / low prevalent ASVs. Note: this will shift the composition of the samples, and thus could bias results. mkdir ancom qiime Read More...
Web Page
Bioinformatics
First, notice that you can easily access columns from the sample metadata ( colData() ) using $ . Using brackets to subset: se$SampleName ## [1] GSM1275862 GSM1275863 GSM1275866 GSM1275867 GSM1275870 GSM1275871 GSM1275874 ## [8] GSM1275875 ## 8 Levels: GSM1275862 GSM1275863 GSM1275866 GSM1275867 ... GSM1275875 se$ Read More...
Web Page
Bioinformatics
For the help sessions, we will work on processing sequences generated in Zhang Z, Feng Q, Li M, Li Z, Xu Q, Pan X, Chen W. Age-Related Cancer-Associated Microbiota Potentially Promotes Oral Squamous Cell Cancer Read More...
Web Page
Bioinformatics
The provided data set is an example of a real count matrix returned from the NCI CCR Sequencing Facility (CCR-SF). The provided file ( ./data/SF_example_RNASeq_1.txt ) contains RNAseq data for two sets of Read More...
Web Page
Employing spatial biology techniques enables acquisition of transcript and protein data from intact tissue sections, and in turn, spatial distribution information and cellular interaction patterns are revealed.
Frederick, MD
Core Facility
The FNLCR Molecular Histopathology Laboratory (MHL) provides comprehensive veterinary pathology support for animal health monitoring, biomarker discovery and validation, drug development, genomics, and proteomics on a cost recovered basis. The MHL is organized into multiple Read More...
Web Page
Employing spatial biology techniques enables acquisition of transcript and protein data from intact tissue sections, and in turn, spatial distribution information and cellular interaction patterns are revealed.
Charlottesville, VA
Repositories
Trans NIH Facility
The Mid-Atlantic CHTN is one of six participating divisions of the Cooperative Human Tissue Network (CHTN) and is based in the Pathology Department at the University of Virginia. While primarily a resource for cancer researchers, Read More...
Bethesda, MD
Core Facility
The Blood Processing Core monitors viral load in patients with HIV and performs sequential studies using samples obtained from patients with cancer, AIDS, chronic granulomatous disease, or other diseases associated with immunologic dysfunction. The core Read More...
Bethesda, MD
Core Facility
Repositories
The mission of Human Brain Collection Core (HBCC) within the National Institute of Mental Health, Division of Intramural Programs (NIMH IRP) is to conduct and support research on brain and behavior, with the goal of Read More...
Rockville, MD
Repositories
Trans NIH Facility
DTP maintains a repository of synthetic compounds and pure natural products that are available to investigators for non-clinical research purposes. The Repository collection is a uniquely diverse set of more than 200,000 compounds that have been Read More...
Bethesda, MD
Core Facility
The CCR Genomics Core is located in Building 41 on the NIH Bethesda campus. The primary goal of the Core is to provide investigators from CCR/NCI and other NIH Institutes access to genomic technologies and Read More...
Web Page
Employing spatial biology techniques enables acquisition of transcript and protein data from intact tissue sections, and in turn, spatial distribution information and cellular interaction patterns are revealed.
Web Page
Back Services: Biophysics Facility offers Tycho as an open-access instrument. This instrument is very easy to use, and no formal training is required. Core staff will help with their first experiment of new Read More...
Frederick, MD
Collaborative
Repositories
The Central Repository provides the research community at the NCI with various cryogenic services, including low-temperature storage from +4° C to -196° C, controlled-rate freezing, computerized inventory and distribution of samples. The Central Repository is operated Read More...
Bethesda, MD
Collaborative
The Spatial Imaging Technology Resource (formerly the Nanoscale Protein Analysis Section of the Collaborative Protein Technology Resource or CPTR) provides expertise and service in state-of-the-art protein analysis technologies to advance CCR research in basic discovery Read More...
Bethesda, MD
Collaborative
The Clinical Flow Cytometry Laboratory provides extensive support for NCI clinical protocols by providing diagnostic testing for leukemia and lymphoma in patients either on NCI clinical protocols or undergoing testing to determine eligibility for NCI Read More...
Web Page
Bioinformatics
05/19/2025 - Immunotherapy has the potential to revolutionize the way we treat cancer, but a key challenge has been finding ways to tailor that therapy to the right patient at the right time. Attend this webinar, Read More...
Web Page
Bioinformatics
03/18/2025 - This class is not hands-on and will demonstrate to participants the use of IGV for visualizing alignment results from Next Generation Sequencing using RNA as an example. After this class, participants will be able Read More...
Web Page
Bioinformatics
03/11/2025 - Clustering is an unsupervised machine learning technique that groups together similar objects (samples, individuals, etc.). Determining the similarity between objects requires a distance metric. This talk provides a brief overview of distance metrics, hierarchical ( Read More...
Web Page
Bioinformatics
03/06/2025 - This class introduces participants to the first steps to differential expression analysis in bulk RNA sequencing which involves filtering out noise from (ie. genes without expression across samples) and performing QC on the gene Read More...
Web Page
Bioinformatics
09/13/2024 - Reverse-phase protein arrays (RPPAs) represent a powerful functional proteomic approach to elucidate cancer-related molecular mechanisms and develop novel cancer therapies. To facilitate community-based investigation of the large-scale protein expression data generated by Read More...
Web Page
Bioinformatics
06/18/2024 - The Cancer Genome Atlas (TCGA) was a landmark cancer genomics program that molecularly characterized over 20,000 primary cancer and matched normal samples spanning 33 cancer types. This resulted in a massive open-source dataset that continues to Read More...
Web Page
Bioinformatics
Integration is the process of aligning the same cell types across samples, treatments, data sets, batches, etc. Clustering should represent biological differences and not technical artifacts. Integration is not always necessary. You should run through Read More...
Web Page
Bioinformatics
Look at the distribution of nCount_RNA with a Violin plot: # set colors cnames% ggplot(aes(color=orig.ident, x=nCount_RNA, fill= orig.ident)) + geom_density(alpha = 0.2) + theme_classic() + scale_x_log10() + geom_vline( Read More...
Web Page
Bioinformatics
Now, we can either use our filtering parameters directly with subset() or provide a cells argument. # use different parameters; established above adp_filt 350 & nCount_RNA >650 & percent.mt
Web Page
Bioinformatics
This tutorial was designed to demonstrate common secondary analysis steps in a scRNA-Seq workflow. We will start with a merged Seurat Object with multiple data layers representing multiple samples. Throughout this tutorial we will Apply Read More...
Web Page
Bioinformatics
This tutorial has been designed to demonstrate common secondary analysis steps in a scRNA-Seq workflow. We will start with a merged Seurat Object with multiple data layers representing multiple samples that have already been filtered Read More...
Web Page
Bioinformatics
In this tutorial, we will continue to use data from Nanduri et al. 2022, Epigenetic regulation of white adipose tissue plasticity and energy metabolism by nucleosome binding HMGN proteins , published in Nature Communications . As a reminder, Read More...
Web Page
Bioinformatics
In this tutorial, we will continue to use data from Nanduri et al. 2022, Epigenetic regulation of white adipose tissue plasticity and energy metabolism by nucleosome binding HMGN proteins , published in Nature Communications . As a reminder, Read More...
Web Page
Bioinformatics
In Seurat (since version 4), differential analysis requires a preprocessing step to appropriately scale the normalized SCTransform assay across samples: adp = PrepSCTFindMarkers(adp) Found 8 SCT models. Recorrecting SCT counts using minimum median counts: 8146 As covered earlier, Read More...
Web Page
Bioinformatics
03/20/2024 - Dear Colleagues, cBioPortal is an open-access resource for interactive exploration of multidimensional cancer genomics data sets, currently providing access to data from >200,000 tumor samples collected from >400 published cancer Read More...
Web Page
Bioinformatics
To access the NIH Partek Flow server, go to https://partekflow.cit.nih.gov/flow and enter the user's NIH username and then password. Note User may have selected a password different than that Read More...
Web Page
Bioinformatics
Accessing Partek Flow at NIH and tips for data transfer Learning objectives Instructions for accessing Partek Flow NCI researchers can find instructions for accessing Partek Flow at https://bioinformatics.ccr.cancer.gov/btep/partek-flow-bulk-and-single-cell-rna-seq-data-analysis/ . But Read More...
Web Page
Bioinformatics
02/16/2024 - Deep sequencing has emerged as the primary tool for transcriptome profiling in cancer research. Like other high-throughput profiling technologies, sequencing is susceptible to systematic non-biological artifacts stemming from inconsistent experimental handling. A critical initial Read More...
Web Page
Bioinformatics
There are data sets available in R to practice with or showcase different packages. For today's lesson and the remainder of this course, we will use data from the Bioconductor package airway to showcase Read More...
Web Page
Bioinformatics
Because we build plots using layers in ggplot2. We can add multiple geoms to a plot to represent the data in unique ways. #We can combine geoms; here we combine a scatter plot with a # Read More...
Web Page
Bioinformatics
01/23/2024 - Looking for data sharing platforms to enhance your research and advance communal knowledge of childhood cancers? Join the first NCI Childhood Cancer Data Initiative (CCDI) webinar of the new year! Read More...
Web Page
Bioinformatics
Bray-Curtis dissimilarity quantitative Takes into consideration abundance and presence absence Jaccard - qualitative - presence / absence - percentage of taxa not found in both samples Weighted UniFrac quantitative similar to Bray-Curtis but takes into consideration Read More...
Web Page
Bioinformatics
Understand the difference between alpha and beta diversity Introduce several alpha diversity metrics Understand what rarefaction is and why it is important Introduce the debate regarding rarefaction and other methods of normalization Often many questions Read More...
Web Page
Bioinformatics
The SummarizedExperiment class and the inherited class RangedSummarizedExperiment are available in the R package SummarizedExperiment . SummarizedExperiment is a matrix-like container where rows represent features of interest (e.g. genes, transcripts, exons, etc.) and columns represent Read More...
Web Page
Bioinformatics
To import we will need to keep in mind that our samples are paired-end with quality information and that we are using a manifest format. Note: Phred 64 quality scores are associated with older data, so Read More...
Web Page
Bioinformatics
This practice lesson is associated with Lesson 4 of the Microbiome Analysis with QIIME 2. In this practice lesson, we will work on filtering our feature table and representative sequences, classify our features, and generate a phylogenetic Read More...
Web Page
Bioinformatics
Practice Lesson 4 This practice lesson is associated with Lesson 4 of the Microbiome Analysis with QIIME 2. In this practice lesson, we will work on filtering our feature table and representative sequences, classify our features, and generate Read More...
Web Page
Bioinformatics
To subset by row, we use the function filter() . filter() only includes rows where the condition is TRUE; it excludes both FALSE and NA values. --- R4DS Now let's filter the rows from Read More...
Web Page
Bioinformatics
Let's use our practice data set again, and see if we can predict group membership (old vs young) by microbial composition. We will use the sample-classifier pipeline. This pipeline splits our data into training Read More...
Web Page
Bioinformatics
Using a small subset of data: Imported raw fastq files using qiime tools import . Data was paired-end CASAVA format. Checked for primers using qiime cutadapt trim-paired . Denoised with qiime dada2 denoise-paired and generated summaries of Read More...
Web Page
Bioinformatics
Lesson 7: Course Wrap-Up Learning Objectives Introduce the QIIME2 microbiome workflow for Biowulf Review key concepts Showcase additional plugins QIIME 2 on Biowulf As mentioned previously, QIIME 2 is installed on Biowulf. To see available versions use module Read More...
Web Page
Bioinformatics
Lesson 4: Feature table filtering, taxonomic classification, and phylogeny Learning objectives learn how to apply different types of filtering to your ASV table and representative sequence data. classify your ASVs. Generate a phylogenetic tree. Now that Read More...
Web Page
Bioinformatics
Why did we focus so heavily on the tidyverse if it can't be used to manipulate Bioconductor objects? Well, for one, regardless of whether you are a user of Bioconductor packages, you will often Read More...
Web Page
Bioinformatics
We can use the airway package to see how this container works, including how to access and subset the data. What is the airway package? There are data sets available in R to practice with Read More...
Web Page
Bioinformatics
The object class used by the DESeq2 package to store the read counts and the intermediate estimated quantities during statistical analysis is the DESeqDataSet. --- Analyzing RNA-seq data with DESeq2 Constructing this object from a Read More...
Web Page
Bioinformatics
We can filter features observed in only a single sample. qiime feature-table filter-features \ --i-table filtered-table-1.qza \ --p-min-samples 2 \ --o-filtered-table filtered-table-2.qza Unless we explicitly remove them, removed features will remain in our FeatureData (Representative Sequences). This Read More...
Web Page
Bioinformatics
Lesson 5: Microbial diversity, alpha rarefaction, alpha diversity Learning Objectives Understand the difference between alpha and beta diversity Introduce several alpha diversity metrics Understand what rarefaction is and why it is important Introduce the debate regarding Read More...
Web Page
Bioinformatics
Practice Lesson 2 For the help sessions, we will work on processing sequences generated in Zhang Z, Feng Q, Li M, Li Z, Xu Q, Pan X, Chen W. Age-Related Cancer-Associated Microbiota Potentially Promotes Oral Squamous Read More...
Web Page
Bioinformatics
This practice lesson is associated with Lesson 6 of the Microbiome Analysis with QIIME 2. In this practice lesson, we will view beta diversity results and determine whether our two conditions (old vs young) demonstrate significant differences Read More...
Web Page
Bioinformatics
Practice Lesson 6 This practice lesson is associated with Lesson 6 of the Microbiome Analysis with QIIME 2. In this practice lesson, we will view beta diversity results and determine whether our two conditions (old vs young) demonstrate Read More...
Web Page
Bioinformatics
Finally, we want to obtain summary information from our feature table and feature data (representative sequences). Our feature table includes count data of our ASVs in each sample, while the feature data provides the sequence Read More...
Web Page
Bioinformatics
S4 objects store complex information that isn't necessarily simple to save. If you intend to work with the object further, try using saveRDS . saveRDS(se, "airways.rds") #save the object Note saveRDS() Read More...
Web Page
Bioinformatics
12/07/2023 - This webinar will discuss and demonstrate experimental design considerations in variant analysis, including the origins of tissue samples (germline vs. somatic), whole exome (WES) or whole-genome sequencing (WGS), sample sizes and statistical power, quality Read More...
Web Page
Bioinformatics
09/13/2023 - FORGEdb is a web-based tool that can rapidly integrate data for individual genetic variants, providing information on associated regulatory elements, transcription factor (TF) binding sites and target genes for over 37 million variants. Read More...
Web Page
Back Services: This instrument is not user accessible. We provide both data collection and data analysis services. Location: Building 50, room 3331 Description: An analytical ultracentrifuge is equipped with absorption and interference optical systems that monitor Read More...
Frederick, MD
Repositories
Trans NIH Facility
DTP’s Natural Products Repository is the world’s largest storehouse of natural products. It houses close to >200,000 extracts from samples of more than 70,000 plants and >20,000 marine organisms collected from more than 29 countries, plus extracts Read More...
Frederick, MD
Core Facility
The Genomics Technology Laboratory is an integrated, high-throughput molecular biology laboratory focusing on the development of genetics and genomics technologies, data analysis, and information management tools, in support of CCR Investigators. The laboratory develops integrated Read More...
Frederick, MD
Core Facility
Repositories
The Mouse Modeling Core assists NIH investigators by generating and preserving genetically-engineered mouse strains. Services include scientific consultation, gene-targeting in mouse embryonic stem cells, micro-injection of nucleic acids, proteins, or ES cells into mouse embryos, Read More...
Bethesda, MD
Collaborative
Our operational objectives are to provide state-of-the-art OMICS technologies in support of the Genetics Branch (GB) investigators and collaborators. Research Services Wet Lab Single cell isolation from fresh, frozen, and FFPE tissue, DNA/RNA extractions Read More...
Frederick, MD
Core Facility
The Clinical Support Laboratory offers processing, tracking, and testing of a broad range of clinical samples. Support can begin at the early stages of clinical trial development to aid in developing a comprehensive strategy for Read More...
Web Page
Back Services: Biophysics Facility offers MP as an open-access instrument. First-time users must complete a short training session before gaining access to the instrument training calendar. Training includes mass distribution analysis of a Read More...
Frederick, MD
Core Facility
Molecular Cytogenetics Core Facility facilitates the assessment of structural and numerical genomic changes in pre-cancer and cancer research models. This core provides comprehensive support for the cytogenetic analysis of cells from human and research animal Read More...
Web Page
Back Services: Biophysics Facility offers DLS as an open-access instrument. First-time users must complete a short training session before gaining access to the instrument reservation calendar. Training includes DLS analysis of small- and large-molecular size Read More...
Bethesda, MD
Collaborative
The Mass Spectrometry Unit of the Collaborative Protein Technology Resource uses mass spectrometry for the study of proteins. We perform collaborative experiments with CCR researchers in areas such as: interactomes, quantitative global proteome analyses, and Read More...
Bethesda, MD
Trans NIH Facility
The NIH Center for Human Immunology, Inflammation, and Autoimmunity (CHI) is a trans-NIH resource whose mission is to provide a collaborative hub of advanced translational immunology for NIH clinical and pre-clinical studies. This uniquely structured Read More...
Web Page
What is Xenium? Xenium is a high-resolution, imaging-based in situ spatial profiling technology from 10x Genomics that allows for simultaneous expression analysis of RNA targets (currently in range of 100’s) within the same tissue section. Read More...
Bethesda, MD
Repositories
Trans NIH Facility
With specimens that span neurological, neuropsychiatric, and neurodevelopmental diseases and disorders, the NBB serves as a central point of access to the world-class collections of our six biorepositories. In addition, the NBB provides researchers with Read More...
Bethesda, MD
Core Facility
The PPS encompasses all scientific analyses related to pharmacology, once the specimen has been collected and stored. There is a multi-step process to evaluate how the drug is being handled by the body after administration. Read More...
Web Page
Services: Biophysics Facility offers CD as an open-access instrument. First-time users must complete a short training session before gaining access to the instrument reservation calendar. Location: Building 50, room 3123 Description: CD spectroscopy measures the difference Read More...
Web Page
Protein Characterization Laboratory (PCL) offers various technologies to CCR investigators to characterize proteins and metabolites. The laboratory develops and applies state-of-the-art analytical technologies, primarily mass spectrometry, liquid chromatography, and Surface Plasmon Resonance (SPR), to advance Read More...
Bethesda, MD
Trans NIH Facility
The facilities at AIM are available for use by the entire NIH intramural research community. While we welcome users with any size imaging project, AIM specializes in large, yearlong (or longer), collaborative research efforts with Read More...
Web Page
Back Services: Biophysics Facility offers CD as an open-access instrument. First-time users must complete a short training session before gaining access to the instrument reservation calendar. Location: Building 50, room 3123 Description: CD spectroscopy measures the Read More...
Web Page
CREx Monthly Newsletter Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More NIH Intramural Core Resources NHGRI Flow Cytometry Core The Core performs high quality single cell analysis through the Read More...
Web Page
CREx Monthly Newsletter Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More New Resources on CREx Trans-NIH Metabolomics Core (TNMC) The TNMC is a shared research resource that provides targeted Read More...
Web Page
CREx Monthly Newsletter Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More NIH Intramural CryoEM (NICE) Consortium NICE provides NCI, NIAID, NIEHS, NICHD, NIDCR, NEI, and NIA investigators with Read More...
Web Page
The Genomics Laboratory (formerly Laboratory of Molecular Technology) is an integrated, high-throughput molecular biology laboratory focusing on the development of genetics and genomics technologies, together with associated laboratory automation systems, data analysis, and information management Read More...
Web Page
Back Services: Biophysics Facility offers ITC calorimeters as open-access instruments. First-time users must complete a short training session before gaining access to the instrument reservation calendar. Training includes performing a test experiment and Read More...
Web Page
Back Services: We offer a limited sample processing service using standard SEC-MALS and FFF protocols. This service is intended for the occasional users of this system. Researchers who expect to use this instrument Read More...
Web Page
Back Services: We offer a limited sample processing service using standard SEC-MALS and FFF protocols. This service is intended for the occasional users of this system. Researchers who expect to use this instrument Read More...
Frederick, MD
Core Facility
Protein Characterization Laboratory (PCL) offers various technologies to CCR investigators to characterize proteins and metabolites. The laboratory develops and applies state-of-the-art analytical technologies, primarily mass spectrometry, liquid chromatography, and Surface Plasmon Resonance (SPR), to advance Read More...
Web Page
CREx Monthly Newsletter Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More. New Resources on CREx NIMH Human Brain Collection Core (HBCC) The HBCC obtains human brain tissue, hair, and blood Read More...
Web Page
CREx Monthly Newsletter Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More NIH Extramural Common Fund Resources Metabolomics Workbench Developed by the NIH Metabolomics Common Fund's National Metabolomics Data Repository ( Read More...
Web Page
Back Services: Biophysics Facility offers MST as an open-access instrument. First-time users must complete a short training session before gaining access to the instrument reservation calendar. Training includes the KD determination of a Read More...
Frederick, MD
Core Facility
The Animal Diagnostic Laboratory (ADL) provides a full range of diagnostic capabilities, including microbiological cultures on various culture medium, microscopic screening for parasites such as mites and pinworms, molecular detection of pathogens, serological evaluation of Read More...
Frederick, Maryland
Core Facility
CLIA-Certified Technologies Offered: Fragment Analysis for Micro-satellite Instability Detection, Pharmacoscan Array for Pharmacogenomics, Mutation Detection for PCR and Sanger Sequencing, DNA extraction from whole blood, saliva, FFPE tissues, buccal swabs, nails, hair, PBMCs, buffy coats, Read More...
Web Page
Back Services: Biophysics Facility offers ZetaView as an open-access instrument. First-time users must complete a short training session before using it for the first time. Training includes instrument calibration and size analysis of a standard Read More...
Web Page
Electron Microscopy Laboratory (EML) The EML offers investigators access to unique expertise and EM technologies that allow our partners to explore new avenues of research to enhance the knowledge of biological systems. To assist our Read More...
Frederick, MD
Core Facility
The EML offers investigators access to unique expertise and EM technologies that allow CCR Investigators to explore new avenues of research in order to enhance the knowledge of biological systems. To assist our customers, we Read More...
Web Page
Total end-to-end system for single-cell research [embed]https://youtu.be/vMzhSzg1rUw[/embed] The BD Rhapsody Single-Cell Analysis system empowers and streamlines your research with a complete system of tools, including reagents and analysis software, Read More...
Web Page
CREx Monthly Newsletter Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More New Resources on CREx Interested in imaging large scale biological samples? Volume electron microscopy allows for Read More...
Frederick, MD
Core Facility
Clinical Support Laboratory – Flow Cytometry Section is a laboratory specializing in providing immunophenotyping support of NCI intramural clinical trials, though assessments may also be performed using cells from Non-human primates and other species. The CSL Read More...
Web Page
Back Services: Biophysics Facility offers Octet as an open-access instrument. First-time users must complete a short training session before gaining access to the instrument reservation calendar. Training includes a full analysis of a Read More...
Web Page
The Center for Advanced Tissue Imaging (CAT-I) is an NIAID and NCI supported effort involving collaborative studies between experts in the Laboratory of Immune System Biology, DIR, NIAID and investigators in the DIR, NIAID and Read More...
Frederick, MD
Collaborative
The NMR Facility for Biological Research operates six NMR spectrometers with proton resonance frequencies from 850 to 500 MHz. Three of the highest field spectrometers (850, 700, 600) are equipped with higher sensitivity cryoprobes optimized for high-resolution multi-dimensional and relaxation Read More...
Web Page
CREx Monthly Newsletter Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More New CREx User Survey The CREx Team is carrying out a CREx User Survey. We would greatly appreciate Read More...
Bethesda, MD
Core Facility
The Genomics and Pharmacology Facility is part of the NCI's Center for Cancer Research (CCR), within the Developmental Therapeutics Branch. Its mission is to manage and assess molecular interaction data obtained through multiple platforms, increase Read More...
Frederick, MD
Collaborative
In order to meet increasing demands from both NIH intramural and extramural communities for access to a small angle X-ray scattering (SAXS) resource, the Center for Cancer Research (CCR) under the leadership of Drs. Jeffrey Read More...
Web Page
Mass Spectrometry Section of the Collaborative Protein Technology Resource (Bldg. 37) Core Capabilities: Identification of proteins in complexes, organelles, subcellular fractions, or fluids. Global relative protein quantitation. Quantitation by isotopic labeling of cells in culture (SILAC) Read More...
Bethesda, MD
Trans NIH Facility
The Mouse Imaging Facility (MIF) is a shared, trans-NIH intramural resource for animal imaging studies. MIF provides access to state-of-the-art radiological imaging methods optimized for mice, rats, other animals, and tissue samples. MIF provides intellectual, Read More...
Bethesda, MD
Collaborative
The Pan-Microbial Serology Facility (PMSF) is part of the Center for Cancer Research (CCR) at the National Cancer Institute (NCI). The PMSF focuses on determining individualized pan-microbial immune profiles associated with human diseases including immunological Read More...
Frederick, Maryland
Core Facility
Repositories
The Biological Products Core provides the AIDS research community with high-quality purified preparations of various strains of Human Immunodeficiency Virus (HIV) and Simian Immunodeficiency Virus (SIV), economically prepared by leveraging the economy of scale. Materials Read More...
Web Page
CREx Monthly Newsletter Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More New CREx User Survey The CREx Team is carrying out a CREx User Survey. If you haven’t Read More...
Web Page
Back Services: Biophysics Facility offers DSC as an open-access instrument. First-time users must complete training before gaining access to the instrument reservation calendar. Location: Building 50, room 3123 Description: The differential scanning calorimeter measures the constant pressure Read More...
Frederick, MD
Core Facility
The CCR-Frederick Flow Cytometry Core Facility provides research support to the Frederick-CCR community, including cytometry analysis and sorting services, instrument maintenance, new user training, and technical consultation. Typical Assays Performed by Core Instruments Immunophenotyping of Read More...
Frederick, MD
Core Facility
The Laboratory Animal Sciences Program (LASP) of the Frederick National Laboratory operates a Gnotobiotics Facility (GF) to support research focused on the role of microbiota in cancer inflammation, pathogenesis, and treatment response. The GF can Read More...
Web Page
What is Visium FFPE v2 with CytAssist? Visium FFPE v2 is sequencing-based spatial profiling technology developed by 10x Genomics. This assay can take mouse or human tissue sections on normal glass slides as input and Read More...
Bethesda, MD
Core Facility
The CCR Building 41 Flow Cytometry Core is a full-service facility within the Center for Cancer Research that supports over 150 users representing 26 laboratories. The Core Facility provides instrument and software training, technical expertise, assay development, and Read More...
Frederick, MD
Core Facility
OMAL focuses its research and development activities to quantitatively understand the molecular basis of three-dimensional (3D) cell organization, motility, invasion, and differentiation using fixed samples and live, 3D tissue culture models (i.e., translational models). Read More...
Web Page
Back Services: Biophysics Facility offers fluorometers as open-access instruments. First-time users must complete a short training session before gaining access to the instrument reservation calendar. Location: Building 50, room 3226 Description: Some substances reemit light after Read More...
Web Page
CREx News & Updates September 2021 Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More NIH Collaborative Research Exchange (CREx) News Site Spotlight FACILITY HIGLIGHTS Learn more about services from the CCR Read More...
Web Page
CREx News & Updates February 2022 Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More Site Spotlight ORS Division of Veterinary Resources (DVR) DVR is the central NIH lab animal support program Read More...
Web Page
Home About the Biophysics Core Biophysics Core Services [tabby title="Instrumentation"] NHLBI Biophysics Core The Biophysics Core Facility: Overview Core Facilities provide scientific resources, cutting-edge technologies and novel approaches to support DIR scientists. Availability of Read More...
Web Page
CREx News & Updates August 2022 Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More Site Spotlight NCATS Functional Genomics Laboratory (FGL) FGL is designed to help NIH Investigators use the latest Read More...
Web Page
CREx News & Updates October 2021 Learn about the NIH Collaborative Research Exchange (CREx), Core Facilities, Webinars, & More NIH Collaborative Research Exchange (CREx) News Site Spotlight FACILITY HIGLIGHTS Learn more about services from the CPTR Read More...
Bethesda, Maryland
Core Facility
Repositories
The AgingResearchBiobank was officially launched in January 2019 with a mission to provide a state-of-the-art inventory system for the storage, maintenance, and distribution of de-identified biospecimens and associated phenotypic, clinical, and imaging data from numerous NIA-funded Read More...
Rockville, MD
Trans NIH Facility
NISC’s role within NHGRI, and more broadly across NIH, aims to advance genome sequencing and its many applications, with a goal not simply to produce sequence data, but to produce the infrastructure required to Read More...
Web Page
[tabby title="Home"] About NICE-NIH Intramural CryoEM Consortium NIH Intramural CryoEM Consortium (NICE) serves intramural investigators in all NIH IC’s. NICE provides access to state-of-the-art Titan Krios cryo-electron microscopes for atomic-resolution structure determination of Read More...
Web Page
Bioinformatics
Congratulations, your experiments have been completed and you have a large amount of data. Now, it’s time to analyze these data. But where do you begin? How can you gain the most meaning from Read More...
Web Page
Bioinformatics
The metadata in the Seurat object is located in adp@metadata and contains the information associated with each cell. We can access the metadata using: head(adp@meta.data) #using head to return only the Read More...
Web Page
Bioinformatics
When using SingleR, the 3 primary parameters are the experimental dataset, the reference dataset, and the labels being used. Continuing with the main labels of the MouseRNASeq dataset on the full dataset looks like this: annot = Read More...
Web Page
Bioinformatics
Some tools have been described in the previous session (see here ). Today, we will be focusing on the SingleR tool, which also requires the celldex package . In short, SingleR operates by comparing your current dataset Read More...
Web Page
Bioinformatics
Clustering is used to group cells by similar transcriptomic profiles. Seurat uses a graph based clustering method. You can read more about it here . The first step is to compute the nearest neighbors of each Read More...
Web Page
Bioinformatics
This lesson provides an introduction to R in the context of single cell RNA-Seq analysis with Seurat. Learning Objectives Learn about options for analyzing your scRNA-Seq data. Learn about resources for learning R programming. Learn Read More...
Web Page
Bioinformatics
Learning Objectives This tutorial was designed to demonstrate common secondary analysis steps in a scRNA-Seq workflow. We will start with a merged Seurat Object with multiple data layers representing multiple samples. Throughout this tutorial we Read More...
Web Page
Bioinformatics
1. Introduction and Learning Objectives This tutorial has been designed to demonstrate common secondary analysis steps in a scRNA-Seq workflow. We will start with a merged Seurat Object with multiple data layers representing multiple samples that Read More...
Web Page
Bioinformatics
05/16/2024 - Qiagen CLC Genomics Workbench is a point-and-click bioinformatics software that runs on a personal computer and enables bulk RNA sequencing, ChIP sequencing, long reads, and variant analysis. NCI scientists can use CLC Genomics Workbench Read More...
Web Page
Bioinformatics
04/01/2024 - Embark on a journey of visionary insights! Join us for the launch of the NEI Informatics & Data-Driven Insights: Seminars & Dialogue Opportunities for Vision Health series, hosted by the National Eye Read More...
Web Page
Bioinformatics
Now let's filter the rows based on a condition. Let's look at only the treated samples in scaled_counts using the function filter() . filter() requires the df as the first argument followed by Read More...
Web Page
Bioinformatics
A way to add variables to a plot beyond mapping them to an aesthetic is to use facets or subplots. There are two primary functions to add facets, facet_wrap() and facet_grid() . If faceting Read More...
Web Page
Bioinformatics
Data visualization with ggplot2 Objectives To learn how to create publishable figures using the ggplot2 package in R. By the end of this lesson, learners should be able to create simple, pretty, and effective figures. Read More...
Web Page
Bioinformatics
Learning Objectives Learn about data structures including factors, lists, data frames, and matrices. Load, explore, and access data in a tabular format (data frames) Learn to write out (export) data from the R environment Data Read More...
Web Page
Bioinformatics
This lesson will introduce data wrangling with R. Attendees will learn to filter data using base R and tidyverse (dplyr) functionality. Learning Objectives Understand the concept of tidy data. Become familiar with the tidyverse packages. Read More...
Web Page
Bioinformatics
Luckily, there is a q2-longitudinal plugin to handle dependent longitudinal data. The q2-longitudinal plugin includes: interactive plotting (e.g., volatility plots) linear mixed effects models paired differences and distances non-metric microbial interdependence testing ( Read More...
Web Page
Bioinformatics
Lesson 6 . Learning Objectives Introduce several beta diversity metrics Discover different ordination methods Learn about statistical methods that are applicable Beta diversity Beta diversity is between sample diversity. This is useful for answering the question, how Read More...
Web Page
Bioinformatics
Objectives To explore Bioconductor, a repository for R packages related to biological data analysis. To better understand S4 objects as they relate to the Bioconductor core infrastructure. To learn more about a popular Bioconductor S4 Read More...
Web Page
Bioinformatics
This practice lesson is associated with Lesson 3 of the Microbiome Analysis with QIIME 2. In this practice lesson, we will work on generating a feature table and representative sequences. We will continue working with the data Read More...
Web Page
Bioinformatics
Practice Lesson 3 This practice lesson is associated with Lesson 3 of the Microbiome Analysis with QIIME 2. In this practice lesson, we will work on generating a feature table and representative sequences. We will continue working with Read More...
Web Page
Bioinformatics
In tab delimited files, data columns are separated by tabs. To import tab-delimited files there are several options. There are base R functions such as read.delim() and read.table() as well as the readr Read More...
Web Page
Bioinformatics
A way to add variables to a plot beyond mapping them to an aesthetic is to use facets or subplots. There are two primary functions to add facets, facet_wrap() and facet_grid() . If faceting Read More...
Web Page
Bioinformatics
Objectives Review important data wrangling functions Put our wrangling skills to use on a realistic RNA-Seq data set Data Wrangling Review Important functions by topic Importing / Exporting Data Importing and exporting data into the R Read More...
Web Page
Bioinformatics
All solutions should use the pipe. Import the file "./data/filtlowabund_scaledcounts_airways.txt" and save to an object named sc . Create a subset data frame from sc that only includes the columns Read More...
Web Page
Bioinformatics
Help Session Lesson 5 All solutions should use the pipe. Import the file "./data/filtlowabund_scaledcounts_airways.txt" and save to an object named sc . Create a subset data frame from sc that only Read More...
Web Page
Bioinformatics
As you can see from the image, there are several accessor functions to access the data from the object: assays() - access matrix-like experimental data (e.g., count data). Rows are genomic features (e.g., Read More...
Web Page
Bioinformatics
Lesson 3: Creating a feature table Lesson Objectives Check for primers Generate an ASV count table and representative sequence file Understand the difference between OTU picking and denoising The two primary files that will be used Read More...
Web Page
Bioinformatics
Introduction to ggplot2 Objectives Learn the ggplot2 syntax. Build a ggplot2 general template. By the end of the course, students should be able to create simple, pretty, and effective figures. Data Visualization in the tidyverse Read More...
Web Page
Bioinformatics
Introduction to dplyr and the %>% Objectives Today we will begin to wrangle data using the tidyverse package, dplyr . To this end, you will learn: how to filter data frames using dplyr how to employ Read More...
Web Page
Bioinformatics
Data import and reshape Objectives 1. Learn to import multiple data types 2. Data reshape with tidyr : pivot_longer() , pivot_wider() , separate() , and unite() Installing and loading packages So far we have only worked with objects that Read More...
Web Page
Bioinformatics
NCI scientists have many choices available to them for bioinformatic analyses of Next Generation Sequencing (NGS) data. While some require expertise in programming, others provide a more user-friendly, point-and-click interface. These options include programs for Read More...
Web Page
Bioinformatics
09/06/2023 - With the advancements in single cell and spatial profiling technologies and methods, some of us thought it would be helpful to re-establish a community of end users on campus. We invite those that are Read More...