All Projects → federicomarini → GeneTonic

federicomarini / GeneTonic

Licence: Unknown, MIT licenses found Licenses found Unknown LICENSE MIT LICENSE.md
Enjoy your transcriptomic data and analysis responsibly - like sipping a cocktail

Programming Languages

r
7636 projects

Projects that are alternatives of or similar to GeneTonic

ideal
Interactive Differential Expression AnaLysis - DE made accessible and reproducible
Stars: ✭ 24 (-63.64%)
Mutual labels:  shiny, reproducible-research, bioconductor, user-friendly, rna-seq-analysis
psichomics
Interactive R package to quantify, analyse and visualise alternative splicing
Stars: ✭ 26 (-60.61%)
Mutual labels:  gene-expression, bioconductor, rna-seq-data
GREIN
GREIN : GEO RNA-seq Experiments Interactive Navigator
Stars: ✭ 40 (-39.39%)
Mutual labels:  gene-expression, rna-seq-analysis, rna-seq-data
Awesome Single Cell
Community-curated list of software packages and data resources for single-cell, including RNA-seq, ATAC-seq, etc.
Stars: ✭ 1,937 (+2834.85%)
Mutual labels:  gene-expression, rna-seq-data
vidger
Make rapid visualizations of RNA-seq data in R
Stars: ✭ 19 (-71.21%)
Mutual labels:  gene-expression, rna-seq-analysis
CD4-csaw
Reproducible reanalysis of a combined ChIP-Seq & RNA-Seq data set
Stars: ✭ 16 (-75.76%)
Mutual labels:  reproducible-research, bioconductor
neuroexpresso
📊 Gene expression in neuroexpresso database
Stars: ✭ 15 (-77.27%)
Mutual labels:  shiny, gene-expression
learning R
List of resources for learning R
Stars: ✭ 32 (-51.52%)
Mutual labels:  shiny, reproducible-research
galaksio
An easy-to-use way for running Galaxy workflows.
Stars: ✭ 19 (-71.21%)
Mutual labels:  reproducible-research, user-friendly
bioc 2020 tidytranscriptomics
Workshop on tidytranscriptomics: Performing tidy transcriptomics analyses with tidybulk, tidyverse and tidyheatmap
Stars: ✭ 25 (-62.12%)
Mutual labels:  bioconductor, transcriptomics
dorothea
R package to access DoRothEA's regulons
Stars: ✭ 98 (+48.48%)
Mutual labels:  gene-expression, bioconductor-package
lncpipe
UNDER DEVELOPMENT--- Analysis of long non-coding RNAs from RNA-seq datasets
Stars: ✭ 24 (-63.64%)
Mutual labels:  transcriptome, rna-seq-analysis
MultiAssayExperiment
Bioconductor package for management of multi-assay data
Stars: ✭ 57 (-13.64%)
Mutual labels:  bioconductor, bioconductor-package
scCATCH
Automatic Annotation on Cell Types of Clusters from Single-Cell RNA Sequencing Data
Stars: ✭ 137 (+107.58%)
Mutual labels:  transcriptome, transcriptomics
circtools
circtools: a modular, python-based framework for circRNA-related tools that unifies several functionalities in a single, command line driven software.
Stars: ✭ 19 (-71.21%)
Mutual labels:  bioconductor
swan vis
A Python library to visualize and analyze long-read transcriptomes
Stars: ✭ 35 (-46.97%)
Mutual labels:  transcriptome
Interactive-3D-Plotting-in-Seurat-3.0.0
This repository contains R code, with which you can create 3D UMAP and tSNE plots of Seurat analyzed scRNAseq data
Stars: ✭ 80 (+21.21%)
Mutual labels:  rna-seq-analysis
fullPage
📄 fullPage.js, pagePiling.js and multiScroll.js for shiny
Stars: ✭ 100 (+51.52%)
Mutual labels:  shiny
targets-minimal
A minimal example data analysis project with the targets R package
Stars: ✭ 50 (-24.24%)
Mutual labels:  reproducible-research
pychopper
A tool to identify, orient, trim and rescue full length cDNA reads
Stars: ✭ 74 (+12.12%)
Mutual labels:  transcriptomics

GeneTonic

R build status Lifecycle: stable Codecov.io coverage status

The goal of GeneTonic is to analyze and integrate the results from Differential Expression analysis and functional enrichment analysis.

This package provides a Shiny application that aims to combine at different levels the existing pieces of the transcriptome data and results, in a way that makes it easier to generate insightful observations and hypothesis - combining the benefits of interactivity and reproducibility, e.g. by capturing the features and gene sets of interest highlighted during the live session, and creating an HTML report as an artifact where text, code, and output coexist.

GeneTonic can be found on Bioconductor (https://www.bioconductor.org/packages/GeneTonic).

If you use GeneTonic in your work, please refer to the original publication 📄 on BMC Bioinformatics (https://bmcbioinformatics.biomedcentral.com/articles/10.1186/s12859-021-04461-5, doi: 10.1186/s12859-021-04461-5).

A preprint 📄 on GeneTonic is available on bioRxiv at https://www.biorxiv.org/content/10.1101/2021.05.19.444862v1.

Installation

You can install the development version of GeneTonic from GitHub with:

library("remotes")
remotes::install_github("federicomarini/GeneTonic", 
                        dependencies = TRUE, build_vignettes = TRUE)

Example

This is a basic example which shows you how to use GeneTonic on a demo dataset (the one included in the macrophage package).

library("GeneTonic")
example("GeneTonic")

# which will in the end run
library("macrophage")
library("DESeq2")
library("org.Hs.eg.db")
library("AnnotationDbi")

# dds object
data("gse", package = "macrophage")
dds_macrophage <- DESeqDataSet(gse, design = ~line + condition)
rownames(dds_macrophage) <- substr(rownames(dds_macrophage), 1, 15)
dds_macrophage <- estimateSizeFactors(dds_macrophage)

# annotation object
anno_df <- data.frame(
  gene_id = rownames(dds_macrophage),
  gene_name = mapIds(org.Hs.eg.db,
                     keys = rownames(dds_macrophage),
                     column = "SYMBOL",
                     keytype = "ENSEMBL"),
  stringsAsFactors = FALSE,
  row.names = rownames(dds_macrophage)
)

# res object
data(res_de_macrophage, package = "GeneTonic")
res_de <- res_macrophage_IFNg_vs_naive

# res_enrich object
data(res_enrich_macrophage, package = "GeneTonic")
res_enrich <- shake_topGOtableResult(topgoDE_macrophage_IFNg_vs_naive)

GeneTonic(dds = dds_macrophage,
          res_de = res_de,
          res_enrich = res_enrich,
          annotation_obj = anno_df,
          project_id = "my_first_genetonic")

Usage overview

You can find the rendered version of the documentation of GeneTonic at the project website https://federicomarini.github.io/GeneTonic, created with pkgdown.

Sneak peek?

Please visit http://shiny.imbei.uni-mainz.de:3838/GeneTonic/ to see a small demo instance running, on the macrophage dataset.

Development

If you encounter a bug, have usage questions, or want to share ideas and functionality to make this package better, feel free to file an issue.

Code of Conduct

Please note that the GeneTonic project is released with a Contributor Code of Conduct. By contributing to this project, you agree to abide by its terms.

License

MIT © Federico Marini

Note that the project description data, including the texts, logos, images, and/or trademarks, for each open source project belongs to its rightful owner. If you wish to add or remove any projects, please contact us at [email protected].