RNA-seq related tools and genomics data analysis resources. Please, contribute and get in touch! See MDmisc notes for other programming and genomics-related notes.
- Pipelines
- Quality control
- Imputation
- Deconvolution
- Batch effect
- Clustering
- Timecourse
- Allele-specific expression
- Differential expression
- Functional enrichment
- Non-canonical RNAs
- CNVs and Structural variations
- Networks
- Integrative
- Classification
- Visualization
- Data
- Misc
-
RNA-seq pipeline developed by NASA GeneLab. FastQC/MultiQC, TrimGalore, STAR (two-pass mode), RSEM (to quantify isiforms), DESeq2. Can normalize using ERCCs. produces unnormalized and normalized counts, more. PCA, heatmaps, other visualization. Step-by-step instructions and commands
- Galazka, Jonathan. “NASA GeneLab RNA-Seq Consensus Pipeline: Standardized Processing of Short-Read RNA-Seq Data,” bioRxiv, November 10, 2020
-
GEO2RNAseq - an R-based RNA-seq processing pipeline, from FASTQ files or directly from GEO. Reads meta-data, oriented for two-group differential analysis. Competitors: Galaxy, the Total RNA-seq Analysis Package for R (TRAP), EasyRNASeq, READemption. Installable through Conda https://anaconda.org/xentrics/r-geo2rnaseq
- Seelbinder, Bastian, Thomas Wolf, Steffen Priebe, Sylvie McNamara, Silvia Gerber, Reinhard Guthke, and Joerg Linde. “GEO2RNAseq: An Easy-to-Use R Pipeline for Complete Pre-Processing of RNA-Seq Data.” Preprint. Bioinformatics, September 16, 2019
-
RNAseq-workflow - A repository for setting up a RNAseq workflow. Detailed instructions and code for each analysis and visualization step.
-
adapters - Adapter sequences for trimming, by Stephen Turner
-
bamcov - Quickly calculate and visualize sequence coverage in alignment files in command line
-
bamtocov - coverage extraction from BAM/CRAM files to wig format
-
bamcount - BigWig and BAM utilities, coverage, by Ben Langmead
-
bigwig-nim - single static binary + liberal license of tool to convert bed to bigwig (and back) and get fast coverage stats from bigwig, by Brent Pedersen, Twitter
-
cgpBigWig - Package of C scripts for generation of BigWig coverage files.
-
covviz - calculate and view coverage based variation
-
indexcov - Quickly estimate coverage from a whole-genome bam or cram index
-
fastq-pair - Match up paired end fastq files quickly and efficiently
-
FastUniq - an ultrafast de novo duplicates removal tool for paired short DNA sequences.
-
faster - A (very) fast program for getting statistics about a fastq file, written in Rust. Get the read length, GC content, mean Phred scores, trim frong and tail, regex search. Compiled binaries are available
-
fgbio tools - general purpose tools for working with sequencing data. Examples of tools for manipulating FASTA/FASTQ files (FastqToBam, TrimFastq), RNA-seq (EstimateRnaSeqInsertSize), SAM/BAM (FilterBam, FindTechnicalReads, SplitBam, TrimPrimers), UMI (CollectDuplexSeqMetrics), VCF/BCF (AssessPhasing, FilterSomaticVcf, FixVcfPhaseSet). GitHub
-
rasusa - Randomly subsample sequencing reads to a specified coverage, single- and paired end reads
-
RSEM tutorial - A short tutorial on how to use RSEM
- Chromap - ultra-fast aligner (>10X faster) for ChIP-seq, Hi-C, scATAC-seq. Based on the minimizer sketch. Memory depends only on genome index size, ~20Gb for human.
Paper
Zhang, Haowen, Li Song, Xiaotao Wang, Haoyu Cheng, Chenfei Wang, Clifford A. Meyer, Tao Liu, et al. “Fast Alignment and Preprocessing of Chromatin Profiles with Chromap.” Nature Communications, 12 November 2021, https://doi.org/10.1038/s41467-021-26865-w
- SNAP - paired-read short-read (70-300bp) aligner based on fussy set intersection. 2-5x faster than BWA-mem2, Bowtie2. When used with Haplotype Caller from the Genome Analysis Toolkit, SNAP produces better concordance with known-truth sets than other aligners for most of the genome-in-a-bottle and Illumina Platinum genomes. Additonal features: accepts SAM and BAM, outputs sorted, duplicate marked and indexed file. Binaries for Windows, Mac, Linux. Tweet.
Paper
Bolosky, William J., Arun Subramaniyan, Matei Zaharia, Ravi Pandya, Taylor Sittler, and David Patterson. “Fuzzy Set Intersection Based Paired-End Short-Read Alignment.” Preprint. Bioinformatics, November 23, 2021. https://doi.org/10.1101/2021.11.23.469039.
- Minimap2 - aligner for long- (SMRT, ONT technologies, over 1kb) and short- (over 100bp, paired-end supported) reads. Spli-read alignment, gap cost for long insertions and deletions, reduces spurious alignment. 3-4 tiimes faster than short-read aligners (C and Python implementation), over 30 times faster than long-read aligners (BLASR, BWA-MEM, GraphMap, minialign, NGMLR). Presets of parameters.
Paper
Li, Heng. “Minimap2: Pairwise Alignment for Nucleotide Sequences.” Edited by Inanc Birol. Bioinformatics 34, no. 18 (September 15, 2018): 3094–3100. https://doi.org/10.1093/bioinformatics/bty191.
-
LongRead_tutorials - Workflows and tutorials for LongRead analysis with specific focus on Oxford Nanopore data. Website
-
lorax - A long-read analysis toolbox for cancer genomics applications. Requires matched tumor-normal data sequenced using long-reads.
-
NGMLR - long-read mapper designed to align PacBio or Oxford Nanopore (standard and ultra-long) to a reference genome with a focus on reads that span structural variations
-
Sniffles - structural variation caller using third generation sequencing (PacBio or Oxford Nanopore).
- GeneTonic - R package for visualization and interpretation of differential expression and functional enrichment analyses results. Heatmaps, volcano plots, PCA, KEGG pathways with gene expression overlay. Shiny app, tutorials, HTML report. Input: differentially expressed genes (DESeq2 preferred), enrichment results (clusterProfiler, Enrichr, others), the
shaker
function processes many data formats. Alternatives. Code to reproduce the paper. GitHub. Demo webserverPaper
Marini, Federico, Annekathrin Ludt, Jan Linke, and Konstantin Strauch. “GeneTonic: An R/Bioconductor Package for Streamlining the Interpretation of RNA-Seq Data.” BMC Bioinformatics 22, no. 1 (December 2021): 610. https://doi.org/10.1186/s12859-021-04461-5.
-
Omics Playground - self-service bioinformatics platform to analyze, visualize, and integrate omics data. Descriptive statistics, differential gene expression, clustering, GSEA/KEGG, signature, cell type prediction. Input - text-based files. R/Shiny implementation, Docker image. GitHub, Documentation
- Akhmedov, Murodzhon, Axel Martinelli, Roger Geiger, and Ivo Kwee. “Omics Playground: A Comprehensive Self-Service Platform for Visualization, Analytics and Exploration of Big Omics Data.” NAR Genomics and Bioinformatics 2, no. 1 (March 1, 2020)
-
Shiny-Seq - Shiny app, and Docker image. Input - a count table, or kallisto output, and annotations. Normalization (DESeq2), batch effect removal (limma or SVA), differential expression analysis (DeSeq2), co-expression network analysis (WGCNA), functional enrichment analysis (clusterprofiler), TFBS motif overrepresentation (pcaGopromoter). Visualization (heatmaps, volcano plots). GitHub. RNA-seq blog post
- Sundararajan, Zenitha, Rainer Knoll, Peter Hombach, Matthias Becker, Joachim L. Schultze, and Thomas Ulas. “Shiny-Seq: Advanced Guided Transcriptome Analysis.” BMC Research Notes 12, no. 1 (December 2019).
-
ARMOR - modular RNA-seq analysis, from raw files, QC, alignment, quantification, differential expression and transcript usage analyses, enrichment analysis, shiny app data exploration, comparible with iSEE (Figure 1). Implemented using Snakemake and Conda for reproducibility. Input - FASTQ files and a metadata file. config.yaml - workflow settings. Data example.
Paper
Orjuela, Stephany, Ruizhu Huang, Katharina M. Hembach, Mark D. Robinson, and Charlotte Soneson. “ARMOR: An Automated Reproducible MOdular Workflow for Preprocessing and Differential Analysis of RNA-Seq Data.” G3: Genes|Genomes|Genetics, May 14, 2019, g3.400185.2019. https://doi.org/10.1534/g3.119.400185.
-
3D_RNA-seq - R package and Shiny app, and Docker image, for differential expression, differential alternative splicing, and differential Transcript Usage. Two- and mutliple group analysis, time course. Input - Salmon/Kallisto transcript quantification files, or .csv. Diagnostic plots, PCA, batch removal using RUVseq, limma-voom for differential expression, iso-kTSP and TSIS for isoform switching between groups and in time course, respectively. Heatmaps, barplots, volcano plots, Venn diagrams. 3D stands for Differential Expression, Differential Alternative Splicing, and Differential Transcript Usage analyses. Web, Manual, GitHub
- Guo, Wenbin, Nikoleta Tzioutziou, Gordon Stephen, Iain Milne, Cristiane Calixto, Robbie Waugh, John WS Brown, and Runxuan Zhang. “3D RNA-Seq - a Powerful and Flexible Tool for Rapid and Accurate Differential Expression and Alternative Splicing Analysis of RNA-Seq Data for Biologists.” Preprint. Bioinformatics, May 31, 2019.
-
DrEdGE - Differential Expression Gene Explorer, Takes in a table of transcript abundance counts, experimental design, other input can be generated in R. Plot, table, heatmap visualization options. Web: http://dredge.bio.unc.edu/ , GitHub: https://github.com/ptgolden/dredge
- Tintori, Sophia C, Patrick Golden, and Bob Goldstein. “Differential Expression Gene Explorer (DrEdGE): A Tool for Generating Interactive Online Data Visualizations for Exploration of Quantitative Transcript Abundance Datasets.” Preprint. Genomics, April 25, 2019.
-
Phantasus - interactive exploratory analyses of genomic data, from clustering, PCA, to enrichment, network, and pathway analyses. Works on user data, ARCHS4, TCGA. https://github.com/ctlab/phantasus. Bioconductor R package and Docker image
-
Qualimap - Qualimap 2 is a platform-independent application written in Java and R that provides both a Graphical User Inteface (GUI) and a command-line interface to facilitate the quality control of alignment sequencing data and its derivatives like feature counts. Supported types of experiments include: Whole-genome sequencing, Whole-exome sequencing, RNA-seq (speical mode available), ChIP-seq
-
fastp - fast C++ parallelized tool for FASTQ quality control, adapter trimming, quality filtering, pruning, polyX (polyG) trimming, works with single- and paired-end data. GitHub
- Chen, Shifu, Yanqing Zhou, Yaru Chen, and Jia Gu. “Fastp: An Ultra-Fast All-in-One FASTQ Preprocessor.” Bioinformatics 34, no. 17 (September 1, 2018)
-
MultiQC - Summarization and visualization QC results for multiple samples in one report. Recognizes multiple QC tools
-
ngsReports - An R Package for managing FastQC reports and other NGS related log files. biorXiv
-
sickle - A windowed adaptive trimming tool for FASTQ files using quality. Post-adapter trimming step
-
fastqc - an R package for quality control (QC) of short read fastq files, analog of the original FASTQC
-
FastQt - FastQC port to Qt5: A quality control tool for high throughput sequence data
-
fastqcheck - Generate statistics on and validate fastq files
-
fancyimpute - Multivariate imputation and matrix completion algorithms implemented in Python. Algorithms: SimpleFill, KNN, SoftImpute, IterativeImputer, IterativeSVD, MatrixFactorization, NuclearNormMinimization, BiScaler.
-
softImpute - R package for Matrix Completion via Iterative Soft-Thresholded SVD, by Trevor Hastie and Rahul Mazumder.
- GEDIT - cell type deconvolution from gene expression data. Supports microarray, RNA-seq data, blood and stromal tissue types, human and mouse species. Includes reference data from 8 sources (Human Skin Signatures, Human Body Atlas, Human Primary Cell Atlas, Blueprint, Encode, LM22, 10X single cell dataset, Immunostates, Tabula Muris, Mouse Body Atlas, ImmGen). Input - gene expression matrix and reference data. Joint quantile normalization, signature score calculation, expression range normalization, non-negative linear regression with no regularization. Compared with CIBERSORT, dtangle, DeconRNASeq, performs better in most cases.
Paper
Nadel, Brian B, David Lopez, Dennis J Montoya, Feiyang Ma, Hannah Waddel, Misha M Khan, Serghei Mangul, and Matteo Pellegrini. “The Gene Expression Deconvolution Interactive Tool (GEDIT): Accurate Cell Type Quantification from Gene Expression Data.” GigaScience 10, no. 2 (January 29, 2021): giab002. https://doi.org/10.1093/gigascience/giab002.
-
ComBat-seq - batch effect correction for RNA-seq data using negative binomial regression. Maintains count nature of RNA-seq data. Tested on simulated data (polyester package), and experimental data. Achieves the highest true positive rate. Code to reproduce paper
- Zhang, Yuqing, Giovanni Parmigiani, and W. Evan Johnson. “ComBat-Seq: Batch Effect Adjustment for RNA-Seq Count Data.” Preprint. Bioinformatics, January 14, 2020.
-
combat.py - python / numpy / pandas / patsy version of ComBat for removing batch effects
- clust - Python package for identification of consistently coexpressed clusters of genes, within and across datasets. Consensus clustering principle. Aproximately 50% of genes do not cluster well and thus shouldn't be considered. Compared with seven tools (cross-clustering, k-means, SOMs, MCL, HC, Click, WGCNA) using seven different cluster validation metrics. Outperforms all, produces more focused and significant functional enrichment results.
- Abu-Jamous, Basel, and Steven Kelly. “Clust: Automatic Extraction of Optimal Co-Expressed Gene Clusters from Gene Expression Data.” Genome Biology 19, no. 1 (December 2018)
- Benchmarking of time course differential analysis tools for RNA-seq. Classical pairwise comparison outperforms specially designed methods in terms of overall performance and robustness to noise. Tested on stimulated data (generated using parameters estimated from ReCount data) and experimental data (GSE69822). AdaptiveGP, DyNB, EbSeqHMM, edgeR/DESeq2 (used as reference gold standard), FunPat, ImpulseDE2, lmms, Next maSigPro, splineTimeR, TimeSeq. Brief description of each method. ImpulseDE2 - overall best performing, comparable with pairwise comparison. Followed by SplineTC on long time series, lmms and others (Discussion). Despite differences, functional enrichment results are similar. GitHub with data and analysis scripts.
Paper
Spies, Daniel, Peter F Renz, Tobias A Beyer, and Constance Ciaudo. “Comparative Analysis of Differential Gene Expression Tools for RNA Sequencing Time Course Data.” Briefings in Bioinformatics 20, no. 1 (January 18, 2019): 288–98. https://doi.org/10.1093/bib/bbx115.
-
LPWC - Lag Penalized Weighted Correlation, a similarity measure to group pairs of time series that are not perfectly synchronized. Review of previous approaches (hierarchical clustering, partition-based, Bayesian models). Correlation-based, with the lag penalty for shift, two options to select it. Best for 5 or more time points, for shorter time course - either use high penalty or another tool STEM. Tested on simulated data (ImpulsDE data) using the adjusted Rand index
- Chandereng, Thevaa, and Anthony Gitter. “Lag Penalized Weighted Correlation for Time Series Clustering.” BMC Bioinformatics 21, no. 1 (December 2020)
-
Time course gene expression analysis review. Biological scenarios requiring a time-course, analytical approaches, Table 1 - software for time course analysis (EDGE, BETR, clustering tools, network analysis).
- Bar-Joseph, Ziv, Anthony Gitter, and Itamar Simon. “Studying and Modelling Dynamic Biological Processes Using Time-Series Gene Expression Data.” Nature Reviews. Genetics 13, no. 8 (July 18, 2012)
-
DREM 2.0 - time course analysis of gene expression data. Detects patterns of gene expression changes and the corresponding transcription factors driving them, motif discovery using protein-DNA (ChIP-seq, ChIP-chip, computational) data, differential motif analysis (DECOD method). Hidden Markov Model-based algorithm. Java tool, GUI and command line interface.
- Schulz, Marcel H, William E Devanny, Anthony Gitter, Shan Zhong, Jason Ernst, and Ziv Bar-Joseph. “DREM 2.0: Improved Reconstruction of Dynamic Regulatory Networks from Time-Series Expression Data.” BMC Systems Biology 6, no. 1 (2012)
- lmerSeq - linear mixed models for RNA-seq data (VST, variance stabilization transformed). Wraps lme4, lmerTest, nlme packages. Tested on synthetic and experimental data vs. DREAM, rmRNA-seq, almost uniformly more powerful, has the best control of FDR. GitHub with tutorials.
Paper
Vestal, Brian E., Elizabeth Wynn, and Camille M. Moore. “LmerSeq: An R Package for Analyzing Transformed RNA-Seq Data with Linear Mixed Effects Models.” BMC Bioinformatics 23, no. 1 (November 16, 2022): 489. https://doi.org/10.1186/s12859-022-05019-9.
- Glimma 2.0 - R package for interactive visualization of DESeq2, edgeR, Limma objects. MDS plot, MA plot, Volcano plot. D3, htmlwidgets, plotly, dygraphs. Plots are embeddable in RMarkdown. Export data as CSV, PNG, SVG. Bioconductor.
Paper
Kariyawasam, Hasaru, Shian Su, Oliver Voogd, Matthew E Ritchie, and Charity W Law. “Dashboard-Style Interactive Plots for RNA-Seq Analysis Are R Markdown Ready with Glimma 2.0.” NAR Genomics and Bioinformatics 3, no. 4 (October 4, 2021): lqab116. https://doi.org/10.1093/nargab/lqab116.
-
Topconfect - differential gene expression using confidence intervals of log fold changes. Confect units are interpretable as effect sizes. Uses TREAT (limma) functionality, Methods, also wraps edgeR and DESeq2 functionality. Tested using simulated and tumor-normal data. R package, GitHub, Bioconductor
- Harrison, Paul F., Andrew D. Pattison, David R. Powell, and Traude H. Beilharz. “Topconfects: A Package for Confident Effect Sizes in Differential Expression Analysis Provides a More Biologically Useful Ranked Gene List.” Genome Biology 20, no. 1 (December 2019)
-
Degust - interactive RNA-seq analysis, RNA-seq exploration, analysis and visualisation
-
diffexpr - A python package using rpy2 to port DESeq2 into Python.
-
ideal - Interactive Differential Expression AnaLysis.
-
EnhancedVolcano - Publication-ready volcano plots with enhanced colouring and labeling, by Kevin Blighe
-
ALDEx - differential abundance analysis of compositional data. ANOVA-like approach, partitioning within-condition to between-condition variation. Uses a Dirichlet-multinomial model to infer abundance from counts. Methods description for transforming proportional data into independent components
- Fernandes, Andrew D., Jean M. Macklaim, Thomas G. Linn, Gregor Reid, and Gregory B. Gloor. “ANOVA-like Differential Expression (ALDEx) Analysis for Mixed Population RNA-Seq.” PloS One 8, no. 7 (2013)
- ASEP - allele-specific (differential) gene expression in a population from RNA-seq. A generalized linear mixed-effects model, the subject-specific random effect accounts for correlation of multiple SNPs within the same gene, and sample heterogeneity is modeled by a two-component mixture distribution. A pseudo-phasing approach (MBASED), 'majority voting'. Type I error is approx. 1%. Input - gene-specific SNP alleles and read counts.
Paper
Fan, Jiaxin, Jian Hu, Chenyi Xue, Hanrui Zhang, Katalin Susztak, Muredach P. Reilly, Rui Xiao, and Mingyao Li. “ASEP: Gene-Based Detection of Allele-Specific Expression across Individuals in a Population by RNA Sequencing.” Edited by Xiaofeng Zhu. PLOS Genetics 16, no. 5 (May 11, 2020): e1008786. https://doi.org/10.1371/journal.pgen.1008786.
- ASEQ - allele-specific gene/transcript expression analysis from paired genomic and transcriptomic sequencing. Does not require paternal and maternal genome data. Concordant with AlleleSeq and MBASED tools. Fast, C implementation.
Paper
Romanel, Alessandro, Sara Lago, Davide Prandi, Andrea Sboner, and Francesca Demichelis. “ASEQ: Fast Allele-Specific Studies from next-Generation Sequencing Data.” BMC Medical Genomics 8, no. 1 (December 2015): 9. https://doi.org/10.1186/s12920-015-0084-2.
- SNPsplit - allele-specific splitting of SAM/BAM alignments using known SNP genotypes. Based on alignment to SNP-masked genomes (N). Perl, three scripts (SNPsplit, SNPsplit_genome_preparation, tag2sort). Input - SAM/BAM files, an annotation file containing the positions of all SNPs in the genome. Performs 1) read tagging and 2) read sorting. Classifies into Allele 1-specific, Allele 2-specific, Unassigned, Conflicting. Works with DNA-seq, RNA-seq, Hi-C, Bisulfite-seq data, single- and paired end, aligned by various aligners. GitHub.
Paper
Krueger, Felix, and Simon R. Andrews. “SNPsplit: Allele-Specific Splitting of Alignments between Genomes with Known SNP Genotypes.” F1000Research 5 (July 2016): 1479. https://doi.org/10.12688/f1000research.9037.2.
- rGREAT - GREAT method for TSS-centric enrichment of genomic regions. Interface with online GREAT, local implementation. Integrates GO, MSigDB, supports more than 600 organisms via BioMartGOGeneSets, custom organisms/annotations support. Results viewable via Shiny app. Different TSS annotations, despite differences, produce similar results. GitHub.
Paper
Gu, Zuguang, and Daniel Hübschmann. “RGREAT: An R/Bioconductor Package for Functional Enrichment on Genomic Regions.” Edited by Tobias Marschall. Bioinformatics, November 17, 2022, btac745. https://doi.org/10.1093/bioinformatics/btac745.
- eVITTA - web tool for interactive gene expression and functional enrichment (GSEA, overrepresentation) analyses. Three modules: 1) easyGEO, retrieval and analysis of GEO datasets; 2) easyGSEA, GSEA or overrepresentation enrichment analyses; 3) easyVizR, comparison among experimental groups (overlap of gene lists and enrichment results). Input: DESeq2/edgeR output, (ranked) gene lists. Output: interactive barplots, heatmaps, volcano plots (plotly), rank-rank hypergeometric overlap (RRHO) plot, networks, enrichment tables. Figure 1, Table 1 - overview of analyses, inputs, outputs. GitHub.
Paper
Cheng, Xuanjin, Junran Yan, Yongxing Liu, Jiahe Wang, and Stefan Taubert. “EVITTA: A Web-Based Visualization and Inference Toolbox for Transcriptome Analysis.” Nucleic Acids Research 49, no. W1 (July 2, 2021): W207–15. https://doi.org/10.1093/nar/gkab366.
-
GSEABenchmarking - an R package for systematic testing of gene set enrichment analyses. 10 major enrichment analyses tested on runtime, % significant sets, type I error rate, relevance to phenotype. Microarray and TCGA RNA-seq data. Best performing - overrepresentation analysis, aka Fisher's, hypergeometric test. Tweet by Levi Waldron
- Geistlinger, Ludwig, Gergely Csaba, Mara Santarelli, Marcel Ramos, Lucas Schiffer, Charity W Law, Nitesh Turaga, et al. “Towards a Gold Standard for Benchmarking Gene Set Enrichment Analysis.” Preprint. Bioinformatics, June 19, 2019.
-
PaintOmics 3 - web tool for KEGG pathway enrichment analysis and visualization of gene expression (also, metabolite, protein, region-based data) over pathway diagrams. Competitors: MapMan, KaPPA-View, Pathview Web. Auto-detection of IDs. Analyzes fold change, time course
- Hernández-de-Diego, Rafael, Sonia Tarazona, Carlos Martínez-Mira, Leandro Balzano-Nogueira, Pedro Furió-Tarí, Georgios J. Pappas, and Ana Conesa. “PaintOmics 3: A Web Resource for the Pathway Analysis and Visualization of Multi-Omics Data.” Nucleic Acids Research 46, no. W1 (July 2, 2018)
-
singscore - a rank-based single-sample enrichment of molecular signatures (R/Bioconductor). Does not depend on background samples, stable for the analysis of small number of samples (<25). Compared woth GSVA, Z-score, PLAGE, ssGSEA, had overall better power, fast. PySingscore - Python implementation. GitHub.
Paper
Foroutan, Momeneh, Dharmesh D. Bhuva, Ruqian Lyu, Kristy Horan, Joseph Cursons, and Melissa J. Davis. “Single Sample Scoring of Molecular Phenotypes.” BMC Bioinformatics 19, no. 1 (December 2018): 404. https://doi.org/10.1186/s12859-018-2435-4.
-
CEMiTool - gene co-expression analysis, reimplements WGCNA, includes selection of a soft-thresholding power using Cauchi distribution, gene enrichment analysis and, optionally, PPI network. Good overview of WGCNA algorithm.
- Russo, Pedro S. T., Gustavo R. Ferreira, Lucas E. Cardozo, Matheus C. Bürger, Raul Arias-Carrasco, Sandra R. Maruyama, Thiago D. C. Hirata, et al. “CEMiTool: A Bioconductor Package for Performing Comprehensive Modular Co-Expression Analyses.” BMC Bioinformatics 19, no. 1 (20 2018)
-
EnrichmentBrowser - R package for microarray/RNA-seq normalization, ID mapping, differential analysis, functional enrichment (many methods) and network analyses and visualization
- Geistlinger, Ludwig, Gergely Csaba, and Ralf Zimmer. “Bioconductor’s EnrichmentBrowser: Seamless Navigation through Combined Results of Set- & Network-Based Enrichment Analysis.” BMC Bioinformatics 17 (January 20, 2016)
-
Metascape - multi-gene lists functional analysis, auto gene ID recognition, >40 databases. data_analysis_portals.xlsx - 25 data analysis portals
- Zhou, Yingyao, Bin Zhou, Lars Pache, Max Chang, Alireza Hadj Khodabakhshi, Olga Tanaseichuk, Christopher Benner, and Sumit K. Chanda. “Metascape Provides a Biologist-Oriented Resource for the Analysis of Systems-Level Datasets.” Nature Communications 10, no. 1 (December 2019)
-
Positional Gene Enrichment analysis of gene sets for high resolution identification of overrepresented chromosomal regions.
-
gProfileR - enrichment of gene lists, from GO to KEGG and others, organism-specific, ortholog conversion. Web interface
-
msigdb4mouse - MSigDB gene sets for mouse (GO, KEGG, Reactome).
-
ChEA3 - predicting regulatory TFs for sets of user-provided genes. Improved backend reference gene set data (six datasets), ranking of the most significantly enriched TFs. Benchmarking against several other TF prioritization tools (overviewed in intro). Docker, API web-interface and downloadable data
- Keenan, Alexandra B., Denis Torre, Alexander Lachmann, Ariel K. Leong, Megan L. Wojciechowicz, Vivian Utti, Kathleen M. Jagodnik, Eryk Kropiwnicki, Zichen Wang, and Avi Ma’ayan. “ChEA3: Transcription Factor Enrichment Analysis by Orthogonal Omics Integration.” Nucleic Acids Research, May 22, 2019.
-
RABIT - find TFs regulating a list of genes. Integrated ChIP-seq and gene expression data, regression framework. Tested in experimental KO data, tumor-profiling cohorts.
- Jiang, Peng, Matthew L. Freedman, Jun S. Liu, and Xiaole Shirley Liu. “Inference of Transcriptional Regulation in Cancers.” Proceedings of the National Academy of Sciences 112, no. 25 (June 23, 2015)
-
RcisTarget - finding enriched motifs in cis-regulatory regions in a gene list
- ITAS - database of transcript annotation for small RNAs. Filtered, corrected, and integrated transcript annotations for several types of small RNAs (miRNA, piRNA, tRNA, rRNA, tsRNA) and several species (human, mouse, rat, fly, worm). Data from miRBase, piRNAdb, GtRNAdb, UCSC, tRFdb, MINTbase. Compared with SPORTS annotation pipeline, detects more transcripts, differentially expressed. Processing scripts.
Paper
Stupnikov, Alexey, Vitaly Bezuglov, Ivan Skakov, Victoria Shtratnikova, J. Richard Pilsner, Alexander Suvorov, and Oleg Sergeyev. “ITAS: Integrated Transcript Annotation for Small RNA.” Non-Coding RNA 8, no. 3 (May 2, 2022): 30. https://doi.org/10.3390/ncrna8030030.
- oddgenes - A list of weird gene annotations or things that break bioinformatics assumptions
-
Benchmarking review, two types of alternative splicing analysis: differential splicing and differential isoform detection. DESeq2, DEXSeq, Limma and NOISeq perform well overall. GitHub
- Merino, Gabriela A, Ana Conesa, and Elmer A Fernández. “A Benchmarking of Workflows for Detecting Differential Splicing and Differential Expression at Isoform Level in Human RNA-Seq Studies.” Briefings in Bioinformatics 20, no. 2 (March 25, 2019)
-
ASpli - integrating several independent measures of alternative splicing. Bin-level analysis of genes/splice junctions (. edgeR to test for differences. Estimates PSI, PIR, PJU, novel junction. Input: BAM files and a genome annotation file. Bioconductor R package
- Mancini, Estefania, Andres Rabinovich, Javier Iserte, Marcelo Yanovsky, and Ariel Chernomoretz. “ASpli: Integrative Analysis of Splicing Landscapes through RNA-Seq Assays,” Bioinformatics, 02 March 2021
-
SUPPA2 - differential splicing from RNA-seq analysis (differences in PSI). TPM-quantified transcripts, handles replicates, accounts for sequencing depth, covariates. Clusters alternatively spliced events (DBSCAN, OPTICS). Compared with rMATS, DEXseq, MAJIQ on simulated data, very fast, accurate. Tutorial based on Salmon quantification
- Trincado, Juan L., Juan C. Entizne, Gerald Hysenaj, Babita Singh, Miha Skalic, David J. Elliott, and Eduardo Eyras. “SUPPA2: Fast, Accurate, and Uncertainty-Aware Differential Splicing Analysis across Multiple Conditions.” Genome Biology, (December 2018)
-
MAJIQ - local splicing variation analysis. Detects canonical and alternative splicing events. Quantifies as Percent Selected In (PSI). Differential splicing as delta PSI. Visualization using VOILA package. Python 3.
- Vaquero-Garcia, Jorge, Alejandro Barrera, Matthew R. Gazzara, Juan González-Vallinas, Nicholas F. Lahens, John B. Hogenesch, Kristen W. Lynch, and Yoseph Barash. “A New View of Transcriptome Complexity and Regulation through the Lens of Local Splicing Variations.” ELife 5 (February 1, 2016)
-
MISO (Mixture-of-Isoforms) is a probabilistic framework that quantitates the expression level of alternatively spliced genes from RNA-Seq data, and identifies differentially regulated isoforms or exons across samples. - By modeling the generative process by which reads are produced from isoforms in RNA-Seq, the MISO model uses Bayesian inference to compute the probability that a read originated from a particular isoform.- MISO treats the expression level of a set of isoforms as a random variable and estimates a distribution over the values of this variable. - The estimation algorithm is based on sampling, and falls in the family of techniques known as Markov Chain Monte Carlo (“MCMC”).
- Katz, Yarden, Eric T. Wang, Edoardo M. Airoldi, and Christopher B. Burge. “Analysis and Design of RNA Sequencing Experiments for Identifying Isoform Regulation.” Nature Methods 7, no. 12 (December 2010)
-
RegTools - integration of somatic variants from DNA-seq and splice junctions from RNA-seq data to identify variants causing aberrant splicing in cancer.
- Feng, Yang-Yang, Avinash Ramu, Kelsy C Cotto, Zachary L Skidmore, Jason Kunisaki, Donald F Conrad, Yiing Lin, et al. “RegTools: Integrated Analysis of Genomic and Transcriptomic Data for Discovery of Splicing Variants in Cancer,” November 25, 2018.
-
rMATS alternative splicing detection tool. Using paired samples.RNA-seq depth and alternative splicing power - 200M reads minimum. rMATS-turbo - 100X faster implementation, Tweet
- Shen, Shihao, Juw Won Park, Zhi-xiang Lu, Lan Lin, Michael D. Henry, Ying Nian Wu, Qing Zhou, and Yi Xing. “RMATS: Robust and Flexible Detection of Differential Alternative Splicing from Replicate RNA-Seq Data.” Proceedings of the National Academy of Sciences of the United States of America 111, no. 51 (December 23, 2014)
-
tappAS - functional impact of alternative splicing. Input - transcript-level count matrix
-
vast-tools - A toolset for profiling alternative splicing events in RNA-Seq data
- Irimia, Manuel, Robert J. Weatheritt, Jonathan D. Ellis, Neelroop N. Parikshak, Thomas Gonatopoulos-Pournatzis, Mariana Babor, Mathieu Quesnel-Vallières, et al. “A Highly Conserved Program of Neuronal Microexons Is Misregulated in Autistic Brains.” Cell 159, no. 7 (December 18, 2014)
-
CancerMIRNome - web server for exploratory miRNA analysis in TCGA cancers and circulating microRNA studies. Query individual miRNAs, cancers. Differential expression, ROC for predicting tumor-normal distinction, survival plots, miRNA-target correlation, functional enrichment of targets. GitHub
- Li, Ruidong, Han Qu, Shibo Wang, Xuesong Wang, Yanru Cui, Lei Yu, John M. Chater, et al. “CancerMIRNome: A Web Server for Interactive Analysis and Visualization of Cancer MiRNome Data.” Preprint. Bioinformatics, October 5, 2020
-
PharmacomiR - miRNA-drug associations analysis
-
microRNAome - read counts for microRNAs across tissues, cell-types, and cancer cell-lines, SummarizedExperiment R package
-
miRNAmeConverter - Convert miRNA Names to Different miRBase Versions
-
MIENTURNET - web tool for miRNA-target enrichment analysis, prioritization, network visualization, functional enrichment for microRNA target genes.
- Licursi, Valerio, Federica Conte, Giulia Fiscon, and Paola Paci. “MIENTURNET: An Interactive Web Tool for MicroRNA-Target Enrichment and Network-Based Analysis.” BMC Bioinformatics 20, no. 1 (December 2019)
-
miRDB - database for miRNA target prediction and functional annotations. The targets were predicted by MirTarget from RNA-seq and CLIP-seq data. Five species: human, mouse, rat, dog and chicken. Custom target prediction. Cell line-specific. Integrative analysis of target prediction and Gene Ontology data.
- Chen, Yuhao, and Xiaowei Wang. “MiRDB: An Online Database for Prediction of Functional MicroRNA Targets.” Nucleic Acids Research, August 31, 2019
-
TAM2 - miRNA enrichment analysis. Manually curated and established miRNA sets. Single list analysis, up vs downregulated. Complementary tools - miSEA, miEAA
- Li, Jianwei, Xiaofen Han, Yanping Wan, Shan Zhang, Yingshu Zhao, Rui Fan, Qinghua Cui, and Yuan Zhou. “TAM 2.0: Tool for MicroRNA Set Analysis.” Nucleic Acids Research 46, no. W1 (July 2, 2018)
-
miRsponge - identification and analysis of miRNA sponge interaction networks and modules. Seven methods for miRNA sponge interaction detection (miRHomology, pc, sppc, hermes, ppc, muTaME, and cernia), and integrative method, description of each method. Four module detection methods (FN, MCL, LINKCOMM, MCODE), description of each. Enrichment analyses - disease (DO, DisGeNet, Network of Cancer Genes), functions (GO, KEGG, REACTOME). Survival analysis.
- Zhang, Junpeng, Lin Liu, Taosheng Xu, Yong Xie, Chunwen Zhao, Jiuyong Li, and Thuc Duy Le. “MiRsponge: An R/Bioconductor Package for the Identification and Analysis of MiRNA Sponge Interaction Networks and Modules.” BioRxiv, January 1, 2018
-
MirGeneDB - standardized microRNA database, 1288 microRNA families across 45 species. Downloadable, FASTA, GFF, BED files. Nomenclature refs 19, 20.
- Fromm, Bastian, Diana Domanska, Eirik Hoye, Vladimir Ovchinnikov, Wenjing Kang, Ernesto Aparicio-Puerta, Morten Johansen, et al. “MirGeneDB 2.0: The Metazoan MicroRNA Complement.” BioRxiv, August 13, 2019.
-
miRPathDB - miRNA-pathway association database, human, mouse
- Backes, Christina, Tim Kehl, Daniel Stöckel, Tobias Fehlmann, Lara Schneider, Eckart Meese, Hans-Peter Lenhof, and Andreas Keller. “MiRPathDB: A New Dictionary on MicroRNAs and Target Pathways.” Nucleic Acids Research 45, no. D1 (January 4, 2017)
- ncFANs v2.0 - functional annotation of non-coding RNAs. Three modules: ncFANs-NET, ncFANs-eLnc and ncFANs-CHIP, for annotations using pre-built coexpression/comethylation/lncRNA-gene regulatory networks (GTeX, TCGA), enhancer-derived lncRNAs (data from GRO-seq, de novo transcript assembly), microarray-based analysis, random forest-predicted networks. Input: lists of ncRNA Ensembl IDs or gene symbols.
Paper
Zhang, Yuwei, Dechao Bu, Peipei Huo, Zhihao Wang, Hao Rong, Yanguo Li, Jingjia Liu et al. "ncFANs v2. 0: an integrative platform for functional annotation of non-coding RNAs." Nucleic Acids Research 49, no. W1 (29 May 2021): W459-W468. https://doi.org/10.1093/nar/gkab435
- LncSEA - long non-coding RNA database and enrichment analysis. Covers over 50K lncRNAs, contains reference sets in 18 categories (Accessible chromatin, enhancer, super enhancer, transcription factor, survival, Drug, Disease, Cancer hallmark, subsellular location etc., Supplementary Table 2 and 3 - data sources) and 66 subcategories (based on specific attributes, overlap/proximal/closest, cancer subtypes, etc.), Table 1. Hypergeometric enrichment, Jaccard, Simpson overlaps, Correction for multiple testing (BH, Bonferroni). ID conversion. Supplementary Material 2 - details of categories. Previous tools: Co-LncRNA, Lnc-GFP, FARNA, LnCompare (Supplementary Table 1 - Comparison of LncSEA with other databases and tools). Supplementary material. GitHub.
Paper
Chen, Jiaxin, Jian Zhang, Yu Gao, Yanyu Li, Chenchen Feng, Chao Song, Ziyu Ning, et al. “LncSEA: A Platform for Long Non-Coding RNA Related Sets and Enrichment Analysis,” Nucleic Acids Research, 8 January 2021. https://doi.org/10.1093/nar/gkaa806
-
lncRNAKB - database of long noncoding RNAs. lncRNAs are typically less conserved, expressed low on average and highly tissue-specific. Combines six resources (CHESS, LNCipedia, NONCODE, FANTOM, MiTranscriptome, BIGTranscriptome). Information about tissue-specific expression, eQTL, WGCNA co-expression to predict functions in a tissue-specific manner, random forest prediction of protein-coding score. Data: GTF gene annotation, tissue-specific expression (TPM, counts, eQTL). RNA-seq blog post
- Seifuddin, Fayaz, Komudi Singh, Abhilash Suresh, Yun-Ching Chen, Vijender Chaitankar, Ilker Tunc, Xiangbo Ruan, et al. “LncRNAKB: A Comprehensive Knowledgebase of Long Non-Coding RNAs.” Preprint. Bioinformatics, June 13, 2019.
-
UClncR - detecting and quantifying expression of unknown and known lncRNAs. Works for unstranded and stranded RNA-seq. Incorporates StringTie, Sebnif for novel lncRNA detection, iSeeRNA for assessing noncoding potential. Annotates lncRNAs by the nearby protein-coding genes. Tested on real data using Gencode annotations with parts of lncRNA annotations removed.
- Sun, Zhifu, Asha Nair, Xianfeng Chen, Naresh Prodduturi, Junwen Wang, and Jean-Pierre Kocher. “UClncR: Ultrafast and Comprehensive Long Non-Coding RNA Detection from RNA-Seq.” Scientific Reports 7, no. 1 (December 2017)
- DCC Python scripts and CircTest R visualization package - circular RNA detection. DCC uses STAR output (chimeric.out.junction) and detects back-splice junctions, filters, integrated replicate data. A much higher precision than competitors (CIRI, KNIFE), similar sensitivity. Tests for host gene-independence of circRNA expression across different experimental conditions.
Paper
Cheng, Jun, Franziska Metge, and Christoph Dieterich. "Specific identification and quantification of circular RNAs from sequencing data." Bioinformatics 32, no. 7 (2016): 1094-1096. https://doi.org/10.1093/bioinformatics/btv656
- CIRCpedia database of cornRNAs from human, mouse, and some model organisms. Ribo-, poly(A)-, RNAse R methods for enriching for circRNAs. CIRCexplorer2 for the analysis of such experiments
- Zhang et al., “Diverse Alternative Back-Splicing and Alternative Splicing Landscape of Circular RNAs.”
- MINTIE - identifying novel, rare transcriptional variants in cancer RNA-seq data. Detects fusions, transcribed structural variants (>=7bp), novel splice variants (flanked by >=20bp), complex variants (Figure 2). Filters, annotates, and prioritizes variants. Case(s) vs. control(s) analysis (single case vs. N controls). Four steps: transcriptome assembly of the case sample (SOAPdenovo-Trans), pseudo-alignment of cases and controls to an index composed of the assembled and reference transcripts (CHESS, Salmon), differential expression to identify upregulated novel features, and annotation of novel transcripts. Outperforms eight other variang detection methods on simulated and experimental datasets.
Cmero, Marek, Breon Schmidt, Ian J. Majewski, Paul G. Ekert, Alicia Oshlack, and Nadia M. Davidson. “MINTIE: Identifying Novel Structural and Splice Variants in Transcriptomes Using RNA-Seq Data.” Genome Biology 22, no. 1 (December 2021): 296. https://doi.org/10.1186/s13059-021-02507-8.
- MetaFusion - gene fusion caller by filtering and aggregating calls from multiple (7 by default) fusion callers (included in Docker/Singularity images, orchestrated by GenPipes). Results are summarized into new Common Fusion Format. Includes FusionAnnotator tool. Documentation.
Paper
Apostolides, Michael, Yue Jiang, Mia Husić, Robert Siddaway, Cynthia Hawkins, Andrei L Turinsky, Michael Brudno, and Arun K Ramani. “MetaFusion: A High-Confidence Metacaller for Filtering and Prioritizing RNA-Seq Gene Fusion Candidates.” Edited by Janet Kelso. Bioinformatics 37, no. 19 (October 11, 2021): 3144–51. https://doi.org/10.1093/bioinformatics/btab249.
-
CICERO - gene fusion detection, uses longer (>75bp) reads, a local assembly-based. Prioritizes candidates. Outperforms ChimeraScan, deFuse, FusionCatcher, Arriba on TCGA brain tumor data. FusionEditor imports CICERO's output for visualization. Imports paired-end FASTQs or aligned BAMs. Supports hg19 only. Web, GitHub
- Tian, Liqing, Yongjin Li, Michael N. Edmonson, Xin Zhou, Scott Newman, Clay McLeod, Andrew Thrasher, et al. “CICERO: A Versatile Method for Detecting Complex and Diverse Driver Fusions Using Cancer RNA Sequencing Data.” Genome Biology 21, no. 1 (December 2020)
-
annoFuse - an R package for standartization, filtering and annotation of fusion calls detected by STAR-Fusion and Arriba, two best methods for fusion detection. Visualization options. Applied to OpenPBTA data.
- Gaonkar, Krutika S., Komal S. Rathi, Payal Jain, Yuankun Zhu, Miguel A. Brown, Bo Zhang, Pichai Raman, et al. “AnnoFuse: An R Package to Annotate and Prioritize Putative Oncogenic RNA Fusions.” Preprint. Bioinformatics, November 12, 2019.
-
ChimerDB is a comprehensive database of fusion genes encompassing analysis of deep sequencing data and manual curations. In this update, the database coverage was enhanced considerably by adding two new modules of TCGA RNA-Seq analysis and PubMed abstract mining
-
TUMOR FUSION GENE DATA PORTAL - Landscape of cancer-associated fusions using the Pipeline for RNA sequencing Data Analysis.
-
FusionScan – prediction of fusion genes from RNA-Seq data. RNA-seq blog post, GitHub
-
Arriba - Fast and accurate gene fusion detection from RNA-Seq data
-
FuSeq - fast fusion detection. Compared with FusionMap, TRUP, TopHat-Fusion, JAFFA, SOAPfuse
- Vu, Trung Nghia, Wenjiang Deng, Quang Thinh Trac, Stefano Calza, Woochang Hwang, and Yudi Pawitan. “A Fast Detection of Fusion Genes from Paired-End RNA-Seq Data.” BMC Genomics 19, no. 1 (December 2018)
-
GeneFuse - Gene fusion detection and visualization
-
EricScript is a computational framework for the discovery of gene fusions in paired end RNA-seq data
- IsoformSwitchAnalyzeR - An R package to Identify, Annotate and Visualize Alternative Splicing and Isoform Switches with Functional Consequences (from RNA-seq data)
- Vitting-Seerup, Kristoffer, and Albin Sandelin. “IsoformSwitchAnalyzeR: Analysis of Changes in Genome-Wide Patterns of Alternative Splicing and Its Functional Consequences.” Bioinformatics, April 15, 2019
- Vitting-Seerup, Kristoffer, and Albin Sandelin. “The Landscape of Isoform Switches in Human Cancers.” Molecular Cancer Research 15, no. 9 (September 2017) - Isoform switching analysis of TCGA data, tumor vs. normal. Consequences, survival prediction. Supplementary data has isoform switching analysis results for all TCGA cancers
-
SuperFreq - CNV analysis from exome data adapted for RNA-seq data. Based on log fold-change variance estimation with the neighbour correction. R package, input - BAM files (reference normal needed), variant calls from samtools or other tools, output - visualization of CNAs, other variant-related plots
- Flensburg, Christoffer, Alicia Oshlack, and Ian J Majewski. “Detecting Copy Number Alterations in RNA-Seq Using SuperFreq” June 01, 2020
-
CaSpER - identification of CNVs from RNA-seq data, bulk and single-cell (full-transcript only, like SMART-seq). Utilized multi-scale smoothed global gene expression profile and B-allele frequency (BAF) signal profile, detects concordant shifts in signal using a 5-state HMM (homozygous deletion, heterozygous deletion, neutral, one-copy-amplification, high-copy-amplification). Reconstructs subclonal CNV architecture for scRNA-seq data. Tested on GBM scRNA-seq, TCGA, other. Compared with HoneyBADGER. R code and tutorials
- Serin Harmanci, Akdes, Arif O. Harmanci, and Xiaobo Zhou. “CaSpER Identifies and Visualizes CNV Events by Integrative Analysis of Single-Cell or Bulk RNA-Sequencing Data.” Nature Communications 11, no. 1 (December 2020)
-
CNAPE - CNV detection from RNA-seq data. Regularized logistic regression (Lasso), trained on TCGA samples. Prediction accuracy >80%. R implementation
- Mu, Quanhua, and Jiguang Wang. “CNAPE: A Machine Learning Method for Copy Number Alteration Prediction from Gene Expression.” IEEE/ACM Transactions on Computational Biology and Bioinformatics, 2019, 1–1.
-
CNVkit-RNA - CNV estimation from RNA-seq data. Improved moving average approach, corrects for GC content, gene expression level, gene length, correlation of gene expression and CNV (estimated from TCGA). Docs, Video tutorial
- Talevich, Eric, and A. Hunter Shain. “CNVkit-RNA: Copy Number Inference from RNA-Sequencing Data.” Preprint. Bioinformatics, September 4, 2018
-
InferCNV - Inferring copy number alterations from tumor single cell RNA-Seq data. R package. GitHub wiki. Part of Trinity Cancer Transcriptome Analysis Toolkit
-
SQUID - transcriptomic structural variation caller. Genome segment graph, then rearrange segments so that as many read alignments as possible are concordant with the rearranged sequence. Compared with MUMmer3, DELLY2, LUMPY in simulated settings, and with SOAPfuse, deFuse, FusionCatcher, JAFFA, INTEGRATE tools using real data
- Ma, Cong, Mingfu Shao, and Carl Kingsford. “SQUID: Transcriptomic Structural Variation Detection from RNA-Seq.” Genome Biology 19, no. 1 (12 2018)
-
transindel - Indel caller for DNA-seq or RNA-seq
- ANANSE (ANalysis Algorithm for Networks Specified by Enhancers) - gene regulatory network inference using TF binding profiles. Missing TF binding profiles predicted from cis-regulatory enhancer activity (H3K27ac, ATAC-seq, EP300), TF motif scores, average ChIP-seq signal of REMAP peaks in enhancers (logistic regression). Influence score - how well the expression differences between two cell types can be explained by a TF. Python implementation. Jupyter notebooks. ANANSE-inferred Tissue-specific networks, cell type-specific networks, GRNBoost2-inferred tissue-specific networks. Tweet.
Paper
Xu, Quan, Georgios Georgiou, Siebren Frölich, Maarten van der Sande, Gert Jan C Veenstra, Huiqing Zhou, and Simon J van Heeringen. “ANANSE: An Enhancer Network-Based Computational Approach for Predicting Key Transcription Factors in Cell Fate Determination.” Nucleic Acids Research 49, no. 14 (August 20, 2021): 7966–85. https://doi.org/10.1093/nar/gkab598.
- MODifieR - R package wrapping 9 gene module inference methods from transcriptomics networks (WGCNA, DIAMOnD, DiffCoEx, MCODE, MODA, Module Discoverer, Clique-Sum, Correlation-Clique). Some methods include differential expression analysis. Consensus module detection. Docker. Vignette.
Paper
Weerd, Hendrik A de, Tejaswi V S Badam, David Martínez-Enguita, Julia Åkesson, Daniel Muthas, Mika Gustafsson, and Zelmina Lubovac-Pilav. “MODifieR: An Ensemble R Package for Inference of Disease Modules from Transcriptomics Networks.” Edited by Lenore Cowen. Bioinformatics 36, no. 12 (June 1, 2020): 3918–19. https://doi.org/10.1093/bioinformatics/btaa235.
- corto - R package for correlation-based gene network and master regulator analysis. Can correct for CNVs. Uses RNA-seq or ATAC-seq data. Benchmarked against ARACNE-AP, minet, RTN. GitHub.
Paper
Mercatelli, Daniele, Gonzalo Lopez-Garcia, and Federico M Giorgi. “[Corto: A Lightweight R Package for Gene Network Inference and Master Regulator Analysis](https://doi.org/10.1093/bioinformatics/btaa223),” Bioinformatics, Volume 36, Issue 12, 15 June 2020
-
GENIE3 - random forest regression detection of gene modules. Input - expression matrix, output - gene x gene square co-regulation matrix
-
PANDA networks - Tissue-Specific Gene Regulatory Networks constructed using PANDA
-
SCENIC networks - Tissue-specific networks inferred from single cell data using SCENIC
-
BARTcancer - predicting the transcriptional regulators from the differentially expressed genes in cancer vs. normal comparison. Database for analyzing TCGA cancers, results separately for up- and downregulated genes. Cross-referenced with Cistrome Cancer
- Thomas, Zachary V., Zhenjia Wang, and Chongzhi Zang. “BART Cancer: A Web Resource for Transcriptional Regulators in Cancer Genomes.” Preprint. Cancer Biology, December 18, 2020.
-
BARTweb - identifying TFs whose genomic binding patterns associate with input genomic features. Input - a gene set, a ChIP-seq mapped read dataset, as scored genomic region set. Adaptive lasso to prioritize TFs. hg38 and mm10 supported. Evaluated on KnockTF data. Similar tools: TFEA.ChIP, ChEA3
- Ma, Wenjing, Zhenjia Wang, Yifan Zhang, Neal E Magee, Yang Chen, and Chongzhi Zang. “BARTweb: A Web Server for Transcription Factor Association Analysis.” Preprint. Bioinformatics, February 17, 2020
-
Review of tools and methods for the integrative analysis of multiple omics data, cancer-oriented. Table 1 - multi-omics data repositories (TCGA, CPTAC, ICGC, CCLE, METABRIC, TARGET, Omics Discovery Index). Three broad areas of multi-omics analysis: 1. Disease subtyping and classification based on multi-omics profiles; 2. Prediction of biomarkers for various applications including diagnostics and driver genes for diseases; 3. Deriving insights into disease biology. Table 2 - software categorized by use case (PARADIGM, iClusterPlus, PSDF, BCC, MDI, SNF, PFA, PINSPlus, NEMO, mixOmics, moCluster, MCIA, JIVE, MFA, sMBPLS, T-SVD, Joint NMF). Brief description of each tool, links, exemplary publications. Table 3 - visualization portals (cBioPortal, Firebrowse, UCSC Xena, LinkedOmics, 3Omics, NetGestalt, OASIS, Paintomics, MethHC). Description of each, data types, analysis examples.
- Subramanian, Indhupriya, Srikant Verma, Shiva Kumar, Abhay Jere, and Krishanpal Anamika. “Multi-Omics Data Integration, Interpretation, and Its Application.” Bioinformatics and Biology Insights, January 31, 2020
-
DIABLO - multi-omics analysis method. Overview of previous methods (SNF, Bayesian Consensus Clustering, NMF, JIVE, sGCCA, MOFA, others). Method extends sGCCA multivariate dimensionality reduction that uses SVD and selects co-expressed (correlated) variables from several omics datasets. Methods, model, iterative solution. Design matrix specifies which omics datasets are connected. Variable selection for biomarkers identification. Visualization options. Part of mixOmics R package, Documentation
- Singh, Amrit, Casey P Shannon, Benoît Gautier, Florian Rohart, Michaël Vacher, Scott J Tebbutt, and Kim-Anh Lê Cao. “DIABLO: An Integrative Approach for Identifying Key Molecular Drivers from Multi-Omics Assays.” Edited by Inanc Birol. Bioinformatics 35, no. 17 (September 1, 2019): 3055–62. https://doi.org/10.1093/bioinformatics/bty1054.
-
MANCIE - matrix analysis and normalization by concordant information enhancement. Bias correction and data integration of distinct genomic profiles on the same samples. Match matrices by rows, run correlation for each row, replace the associated row with modified values using a PCA procedure, Methods. Tested on integration of DHS and gene expression data, TCGA and METABRIC data. R package
- Zang, Chongzhi, Tao Wang, Ke Deng, Bo Li, Sheng’en Hu, Qian Qin, Tengfei Xiao, et al. “High-Dimensional Genomic Data Bias Correction and Data Integration Using MANCIE.” Nature Communications 7, no. 1 (December 2016).
-
JIVE - Joint and Individual Variation Explained. Decomposition of (X) multiple (i) omics datasets into three terms: low-rank (constrained) matrices capturing joint variation (J), plus structured variation (A_i) and residual noise. Data are row-centered and scaled by its total variation. Main constrain: the rows of joint and individual matrices should be orthogonal. Estimate matrices by iteratively minimizing ||R||^2 (R=X-J-A). Relationship to PCA, CCA, PLS. Illustrated on TCGA GBM gene expression, methylation, and miRNA data, with interpretation. Matlab code, r.jive package
- Lock, Eric F., Katherine A. Hoadley, J. S. Marron, and Andrew B. Nobel. “JOINT AND INDIVIDUAL VARIATION EXPLAINED (JIVE) FOR INTEGRATED ANALYSIS OF MULTIPLE DATA TYPES.” The Annals of Applied Statistics 7, no. 1 (March 1, 2013)
-
List of software packages for multi-omics analysis, by Mike Love. Slides for the talk "Assessing consistency of unsupervised multi-omics methods".
- MLSeq - Machine learning interface for RNA-Seq data
- Zararsız, Gökmen, Dincer Goksuluk, Selcuk Korkmaz, Vahap Eldem, Gozde Erturk Zararsiz, Izzet Parug Duru, and Ahmet Ozturk. “A Comprehensive Simulation Study on Classification of RNA-Seq Data.” PLOS ONE 12, no. 8 (August 23, 2017)
-
chromoMap - an R package/function for visualizing BED-like data across chromosomes. Static and interactive (Shiny embeddable) plots, segment-, point-, barplot-, scatterplot visualization. Filters to color visualization by criteria. Colors, spacing, height/width - all customizable. Supports multiple organisms. Documentation, tutorial
- Anand, Lakshay, and Carlos M Rodriguez Lopez. “ChromoMap: An R Package for Interactive Visualization and Annotation of Chromosomes” bioRxiv, January 23, 2020
-
Hiplot - a web tool for publication-ready biomedical data visualization (command line interpreter Hctl written in Go is available). From heatmaps, correlograms to dimensionaliry reduction, other plots (over 240). Basic statistics, multi-omics, regression, clustering, dimensionality reduction, meta-analysis, survival analysis, risk modelling, etc., highly adjustable. Wraps other packages, such as immundeconv, circos. JSON-based plugin system, hiplotlib - development library, plugin-preview - JSON-based previewer to debug plugins. Demo data, data spreadsheet/upload/remote access, SVG download. Created in collaboration with OpenBiox consortium. Table 1 - comparison with competitors, ImageGP and Galaxy.
Paper
Li, Jianfeng, Benben Miao, Shixiang Wang, Wei Dong, Houshi Xu, Chenchen Si, Wei Wang, et al. “Hiplot: A Comprehensive and Easy-to-Use Web Service for Boosting Publication-Ready Biomedical Data Visualization.” Briefings in Bioinformatics 23, no. 4 (July 18, 2022): bbac261. https://doi.org/10.1093/bib/bbac261.
-
genomation - a toolkit for annotation and visualization of genomic data, R package
-
karyoploteR - An R/Bioconductor package to plot arbitrary data along the genome
-
pcaExplorer - Interactive Visualization of RNA-seq Data Using a Principal Components Approach, R package
-
WIlsON - Web-based Interactive Omics VisualizatioN, accepts, text files, SummarizedExperiment datasets. R/Shiny, installs as a package. Docker image available. Web demo.
Paper
H. Schultheis, C. Kuenne, J. Preussner, R. Wiegandt, A. Fust, M. Bentsen and M. Looso. WIlsON: Webbased Interactive Omics VisualizatioN. Bioinformatics 35(6) 2018, doi: https://doi.org/10.1093/bioinformatics/bty711
-
ARCHS4 - Massive Mining of Publicly Available RNA-seq Data from Human and Mouse
-
cBioPortalData - cBioPortal data as MultiAssayExperiment objects, by Waldron Lab
-
curatedTCGAData - Curated Data From The Cancer Genome Atlas (TCGA) as MultiAssayExperiment objects, by Waldron Lab
-
gtexRNA - R package for retrieval of tissue-specific expression data from GTEx. By Sigve Nakken, website
-
GTEx Visualizations - web-based visualization tools for exploring tissue-specific gene expression and regulation
-
PINS - A novel method for data integration and disease subtyping
-
refine.bio - harmonized microarray and RNA-seq data for various organisms and conditions
-
recount2 - an R workflow to work with recount2 data
-
GREIN - re-analysis of RNA-seq datasets from GEO. Download processed data, visualization, power analysis, differential expression, functional enrichment analysis, connectivity analysis with LINCS L1000 data. GitHub, Docker image
- Al Mahi, Naim, Mehdi Fazel Najafabadi, Marcin Pilarczyk, Michal Kouril, and Mario Medvedovic. “GREIN: An Interactive Web Platform for Re-Analyzing GEO RNA-Seq Data,” October 27, 2018
-
DEE2 - Digital Expression Explorer - gene- and transcript-level processed data from multiple organisms, amenable for downstream analysis in R etc. getDEE2 R package to get the data
- Ziemann, Mark, Antony Kaspi, and Assam El-Osta. “Digital Expression Explorer 2: A Repository of Uniformly Processed RNA Sequencing Data.” GigaScience 8, no. 4 (April 1, 2019)
-
GEMMA - curated transcriptomic database, >10,000 studies, ~34% are brain-related. Query genes, phenotypes, experiments, search for coexpression, differential expression. Processing methods, batch correction. Online access, API, R package. GitHub
- Lim, Nathaniel, Stepan Tesar, Manuel Belmadani, Guillaume Poirier-Morency, Burak Ogan Mancarci, Jordan Sicherman, Matthew Jacobson, Justin Leong, Patrick Tan, and Paul Pavlidis. “Curation of over 10,000 Transcriptomic Studies to Enable Data Reuse.” Preprint. Bioinformatics, July 14, 2020.
-
Enrichr - enrichment analysis, gene search, term search. Libraries for various signatures are available for download
-
CellMarker - Cell markers of different cell types from different tissues in human and mouse.
-
A list of updated 1439 DNA-binding transcription factors from re-annotation study of transcription factors in Gene Ontology annotations
- Lovering, Ruth C., Pascale Gaudet, Marcio L. Acencio, Alex Ignatchenko, Arttu Jolma, Oriol Fornes, Martin Kuiper, et al. “A GO Catalogue of Human DNA-Binding Transcription Factors.” BioRxiv, January 1, 2020
-
List of gene lists for genomic analyses - GitHub repo with tab-separated annotated lists
-
CREEDS - database of manually (and automatically) extracted gene signatures. Single gene perturbations, disease signatures, single drug perturbations. Batch effect correction, when necessary. Overall, good agreement with MSigDb C2. Characteristic Direction (CD) method to detect differential genes. API access in R
- Wang, Zichen, Caroline D. Monteiro, Kathleen M. Jagodnik, Nicolas F. Fernandez, Gregory W. Gundersen, Andrew D. Rouillard, Sherry L. Jenkins, et al. “Extraction and Analysis of Signatures from the Gene Expression Omnibus by the Crowd.” Nature Communications 7, no. 1 (November 2016)
-
DIOPT - finding ortholog genes among human, mouse, zebrafish, C. elegans, Drozophila, S. cerevisiae. Integration with human GWAS allows to search for orthologs for diseases and traits. Batch conversion, filtering. DIOPT-DIST - DIOPT Diseases and Traits.
Paper
Hu, Yanhui, Ian Flockhart, Arunachalam Vinayagam, Clemens Bergwitz, Bonnie Berger, Norbert Perrimon, and Stephanie E Mohr. “An Integrative Approach to Ortholog Prediction for Disease-Focused and Other Functional Studies.” BMC Bioinformatics 12, no. 1 (December 2011): 357. https://doi.org/10.1186/1471-2105-12-357.
-
OGEE v3 - online gene essentiality database. Experimentally validated using CRISPR and RNAi. All data (essential genes, their properties, expression data and more) are downloadable
- Gurumayum, Sanathoi, Puzi Jiang, Xiaowen Hao, Tulio L Campos, Neil D Young, Pasi K Korhonen, Robin B Gasser, et al. “OGEE v3: Online GEne Essentiality Database with Increased Coverage of Organisms and Human Cell Lines”
-
HGNChelper - Identify and Correct Invalid HGNC Human Gene Symbols and MGI Mouse Gene Symbols
-
gencode_regions - Extract 3'UTR, 5'UTR, CDS, Promoter, Genes, Introns etc from GTF files, by Saket Choudhary
-
CHESS - Comprehensive Human Expressed SequenceS, database of novel genes, identified from GTeX data, protein-coding and lncRNA
-
ideogram - Chromosome visualization with D3.js. Examples. ideogRam R wrapper
-
Enhancer-promoter (EP) pairs from Thurman et al., (2012)
-
pysradb - Python package for interacting with SRAdb and downloading datasets from SRA, by Saket Choudhary. Documentation
-
GEOparse - Python library to access Gene Expression Omnibus Database (GEO). Documentation
-
ffq - A tool to find sequencing data and metadata from public databases (GEO, SRA, EMBL-EBI, others).
-
RRHO - Rank–rank Hypergeometric Overlap between two gene lists ranked by the degree of differential expression (e.g., signed -log10 p-value). 2D analog of GSEA. Identifies and visualizes areas of significant overlap by determining the degree of statistical enrichment using the hypergeometric distribution while sliding across all possible thresholds through the two ranked lists. Multiple testing correction (FWER, Benjamini-Yekutieli). Website and R/Bioconductor RRHO package.
Paper
Plaisier, Seema B, Richard Taschereau, Justin A Wong, and G Graeber. “Rank–Rank Hypergeometric Overlap: Identification of Statistically Significant Overlap between Gene-Expression Signatures.” Nucleic Acids Research 38, no. 17 (2010): 17. https://doi.org/10.1093/nar/gkq636
-
gffio - tool to process GFF3 and GTF files. It can convert between GFF3 and GTF, generate 12-column BED, extract CDS/transcript/protein sequences, reorder features and select the longest CDS/transcript. By Heng Li
-
gtftk - A python package and a set of shell commands to handle GTF files. Subcommands for editing GTF files, getting information and summary statistics, selecting by various criteria, converting BED to gtf and other formats, annotating by closest genes and more, getting sequences, coordinates of specific gene elements, coverage profile and other bigWig operations.
- Ferre, Q, G Charbonnier, N Sadouni, F Lopez, Y Kermezli, S Spicuglia, C Capponi, B Ghattas, and D Puthier. “OLOGRAM: Determining Significance of Total Overlap Length between Genomic Regions Sets,” Bioinformatics, 15 March 2020 - OLOGRAM - overlap statistics between sets of genomic regions (BED or GTF). Uses Monte Carlo simulation to model (negative binomial) both the distributions of region length and inter-region length, fast. Supplementary data: Table 1 - comparison of features with Genomic Hyperbrowser, GREAT, CEAS, Bedtools fisher, LOLA. Note - details of the method, test results on experimental data. Supplementary GitHub repo - Snakefiles to generate figures.
-
Recommended Coverage and Read Depth for NGS Applications, by GenoHub. And, their NGS Handbook
-
BioJupies - analysis of GEO/GTEx data or your own gene expression table/FASTQ in autogenerated Jupyter notebook. Rich set of tools for EDA (PCA, Clustergrammer, Library size analysis), Differential expression analysis (Volcano, MA plots), Enrichment analysis (Enrichr, GO, Pathway, TF, Kinase, miRNA enrichments), L1000 signatures. Best suited for two-group analysis. Includes Methods for the selected tools
-
HGNChelper - Handy Functions for Working with HGNC Gene Symbols and Affymetrix Probeset Identifiers
-
tximport
- importing transcript abundance datasets from Salmon, Sailfish, kallisto, RSEM, and differential analysis -
rpkmforgenes - a Python script for calculating gene expression for RNA-Seq data
-
Python interface to access reference genome features from Ensembl, e.g., genes, transcripts, and exons
-
TPMcalculator - converts gene counts to TPM using transcript information from a GTF file. TPM vs. FPKM correlation for validation. C/C++ command line tool, Docker image, CWL workflow
- Vera Alvarez, Roberto, Lorinc Sandor Pongor, Leonardo Mariño-Ramírez, and David Landsman. “TPMCalculator: One-Step Software to Quantify MRNA Abundance of Genomic Features.” Bioinformatics 35, no. 11 (June 1, 2019)