Upload your differential expression tables, counts, and metadata
Start with raw counts and perform differential expression analysis
Perform differential expression analysis of count data or import a DEG table you already have.
Filter and explore differentially expressed genes with dynamic tables
Create volcano plots, heatmaps, PCA plots, and dimension reduction visualizations
Perform GO enrichment and KEGG pathway analysis on your gene sets
DECODeR (Differential exploration of counts-based omics data in R) is an interactive toolkit designed by the University of Florida Health Cancer Center BCB-SR Bioinformatics unit for comprehensive analysis and visualization of RNA-seq data. Upload your DEG results or perform differential expression analysis on your counts to create publication-ready plots, explore differential expression patterns, and conduct downstream analyses—all through an intuitive web interface.
Questions about this app or your analysis? Contact UFHCC-BCBSR@ufl.edu
Upload your files to begin analysis and visualization
I have normalized data and differential expression results
I need to perform differential expression analysis
Load example RNA-seq data instantly
Since you have raw counts, you can perform differential expression analysis directly in DECODeR.
The results will automatically be available to all visualization modules - no need to upload anything here!
Guided statistical analysis for RNA-seq count data
Interactive visualization of differential gene expression with significance thresholds
Comprehensive analysis with PCA, UMAP, and sample correlation assessment
PCA: Linear dimensionality reduction showing major variance patterns.
UMAP: Non-linear reduction revealing local clustering structure.
Correlation: Sample-to-sample similarity matrix for quality assessment.
Variance filtering: Uses most variable genes rather than differential expression.
Interpretation Guide:
Visualize gene expression patterns across samples and conditions
Custom Gene Upload:
Upload a CSV or TSV file with a 'SYMBOL' column containing gene names.
Load example gene list instantly
Row scaling: Gene expression values are standardized (z-score) across samples to highlight relative changes.
Clustering: Hierarchical clustering groups similar genes (rows) and samples (columns).
Colors: Intensity represents expression relative to each gene's average across all samples.
Browse, filter, and export differentially expressed genes with statistical summaries
Sorting: Click column headers to sort data.
Search: Use column filters to find specific genes.
Export: Use table buttons to export results.
Colors: Red = up-regulated, Blue = down-regulated.
Export Options: Use the buttons above the table to download results in various formats (CSV, Excel, PDF).
Gene Ontology and KEGG pathway enrichment analysis for differential expression results
Gene Ontology: Systematic classification of gene functions across three domains.
Enrichment: Statistical overrepresentation of GO terms in your gene set.
Visualization: Multiple plot types reveal different aspects of enrichment patterns.
Interpretation: Lower p-values and higher gene ratios indicate stronger enrichment.
KEGG Pathways: Comprehensive database of biological pathways and molecular interactions.
Pathway Analysis: Identifies significantly enriched biological pathways in your gene set.
Pathway View: Interactive pathway diagrams show your genes mapped onto biological pathways.
Applications: Understand biological processes and mechanisms underlying your experimental results.
Differential Exploration of Counts-based Omics Data in R
DECODeR is an interactive toolkit designed by the University of Florida Health Cancer Center Bioinformatics and Computational Biology Shared Resource (BCB-SR) to support comprehensive analysis and visualization of RNA-seq data. The platform enables researchers to upload their own data or perform differential expression analysis directly within the application.
Q: Should I upload normalized or raw count data?
A: It depends on your workflow. For differential expression analysis within DECODeR, upload raw counts. If you already have DEG results, upload normalized data (logCPM) along with your DEG table for visualization.
Q: Why do you use different data types for analysis vs. visualization?
A: Differential expression analysis requires raw counts to properly model the count-based nature of RNA-seq data. However, visualizations (PCA, heatmaps) work better with log-transformed, normalized data (logCPM) to reduce the influence of highly expressed genes.
Q: What file formats do you accept?
A: We accept CSV, TSV, and Excel files. Count matrices should have genes as rows and samples as columns. Metadata should include sample IDs that match your count matrix column names.
Q: Can I analyze complex experimental designs?
A: Currently, DECODeR supports two-group comparisons (multiple contrasts are fine) and designs with batch effects. Support for more complex designs (time series, factorial designs, etc.) is planned for future updates.
Q: How do I handle batch effects or unwanted variation?
A: DECODeR can detect and adjust for known batch effects when performing differential analysis. Advanced methods for removing unknown sources of variation (SVA, RUVseq) are planned for future releases.
Q: Which differential expression method should I use?
A: All three methods (DESeq2, limma-voom, edgeR) are robust. DESeq2 is generally recommended for smaller sample sizes, limma-voom for larger studies, and edgeR offers the fastest performance. Results are typically highly concordant.
Q: When will new features be available?
A: We continuously update DECODeR based on user feedback. Check back regularly for new features or contact us with specific requests.
This section describes the computational methods implemented in each DECODeR module:
Low-abundance genes are filtered using edgeR's filterByExpr() function, which removes genes with consistently low counts across samples. This reduces multiple testing burden and improves statistical power (Robinson MD, et al. Bioinformatics 2010).
When batch information is provided, DECODeR assesses batch effects using principal component analysis and visualization. The user should then include the batch variable as a covariate when they configure their analysis. Currently we do not provide batch corrected counts for visualization purposes, but this is planned for a future release.
DECODeR utilizes several additional R packages for data processing and visualization:
DECODeR is developed and maintained by the UFHCC Bioinformatics and Computational Biology Shared Resource.
For technical support or questions: UFHCC-BCBSR@ufl.edu
For collaboration inquiries: Visit cancer.ufl.edu/research/shared-resources