Enter the query into the form above. You can look for specific version of a package by using @ symbol like this: gcc@10.
API method:
GET /api/packages?search=hello&page=1&limit=20
where search is your query, page is a page number and limit is a number of items on a single page. Pagination information (such as a number of pages and etc) is returned
in response headers.
If you'd like to join our channel webring send a patch to ~whereiseveryone/toys@lists.sr.ht adding your channel as an entry in channels.scm.
The STRINGdb package provides an R interface to the STRING protein-protein interactions database. STRING is a database of known and predicted protein-protein interactions. The interactions include direct (physical) and indirect (functional) associations. Each interaction is associated with a combined confidence score that integrates the various evidences.
The fishpond package contains methods for differential transcript and gene expression analysis of RNA-seq data using inferential replicates for uncertainty of abundance quantification, as generated by Gibbs sampling or bootstrap sampling. Also the package contains a number of utilities for working with Salmon and Alevin quantification files.
This package provides functionality for interactive visualization of RNA-seq datasets based on Principal Components Analysis. The methods provided allow for quick information extraction and effective data exploration. A Shiny application encapsulates the whole analysis.
Data package for JASPAR2020. To explore these databases, utilize the TFBSTools package (version 1.23.1 or higher).
This package contains functions for removing batch effects and other unwanted variation in high-throughput experiment. It also contains functions for identifying and building surrogate variables for high-dimensional data sets. Surrogate variables are covariates constructed directly from high-dimensional data like gene expression/RNA sequencing/methylation/brain imaging data that can be used in subsequent analyses to adjust for unknown, unmodeled, or latent sources of noise.
This package defines low-level functions for mass spectrometry data and is independent of any high-level data structures. These functions include mass spectra processing functions (noise estimation, smoothing, binning), quantitative aggregation functions (median polish, robust summarisation, etc.), missing data imputation, data normalisation (quantiles, vsn, etc.) as well as misc helper functions, that are used across high-level data structure within the R for Mass Spectrometry packages.
This package implements the gene expression anti-profiles method. Anti-profiles are a new approach for developing cancer genomic signatures that specifically take advantage of gene expression heterogeneity. They explicitly model increased gene expression variability in cancer to define robust and reproducible gene expression signatures capable of accurately distinguishing tumor samples from healthy controls.
This package provides functions to plot data associated with arbitrary genomic intervals along chromosomal ideogram.
This package works analogous to BiocManager but for Docker images. Use the BiocDockerManager package to install and manage Docker images provided by the Bioconductor project.
This package is a computational tool box for radio-genomic analysis which integrates radio-response data, radio-biological modelling and comprehensive cell line annotations for hundreds of cancer cell lines. The RadioSet class enables creation and manipulation of standardized datasets including information about cancer cells lines, radio-response assays and dose-response indicators. Included methods allow fitting and plotting dose-response data using established radio-biological models along with quality control to validate results. Additional functions related to fitting and plotting dose response curves, quantifying statistical correlation and calculating AUC or SF are included.
BgeeCall allows generating present/absent gene expression calls without using an arbitrary cutoff like TPM<1. Calls are generated based on reference intergenic sequences. These sequences are generated based on expression of all RNA-Seq libraries of each species integrated in Bgee.
BioQC performs quality control of high-throughput expression data based on tissue gene signatures. It can detect tissue heterogeneity in gene expression data. The core algorithm is a Wilcoxon-Mann-Whitney test that is optimised for high performance.
This package provides an implementation of an algorithm for determining cluster count and membership by stability evidence in unsupervised analysis.
This is an annotation package for Illumina's EPIC methylation arrays.
The ReportingTools package enables users to easily display reports of analysis results generated from sources such as microarray and sequencing data. The package allows users to create HTML pages that may be viewed on a web browser, or in other formats. Users can generate tables with sortable and filterable columns, make and display plots, and link table entries to other data sources such as NCBI or larger plots within the HTML page. Using the package, users can also produce a table of contents page to link various reports together for a particular project that can be viewed in a web browser.
This package provides tools for representing and modeling data in the EMBL-EBI GWAS catalog.
The MBECS provides a set of functions to evaluate and mitigate unwated noise due to processing in batches. To that end it incorporates a host of batch correcting algorithms (BECA) from various packages. In addition it offers a correction and reporting pipeline that provides a preliminary look at the characteristics of a data-set before and after correcting for batch effects.
R-msigdb provides the Molecular Signatures Database in a R accessible objects. Signatures are stored in GeneSet class objects form the GSEABase package and the entire database is stored in a GeneSetCollection object. These data are then hosted on the ExperimentHub. Data used in this package was obtained from the MSigDB of the Broad Institute. Metadata for each gene set is stored along with the gene set in the GeneSet class object.
This is a package for parsing Affymetrix files (CDF, CEL, CHP, BPMAP, BAR). It provides methods for fast and memory efficient parsing of Affymetrix files using the Affymetrix' Fusion SDK. Both ASCII- and binary-based files are supported. Currently, there are methods for reading chip definition file (CDF) and a cell intensity file (CEL). These files can be read either in full or in part. For example, probe signals from a few probesets can be extracted very quickly from a set of CEL files into a convenient list structure.
The atSNP package performs affinity tests of motif matches with the SNP (single nucleotide polymorphism) or the reference genomes and SNP-led changes in motif matches.
r-pathview is a tool set for pathway based data integration and visualization. It maps and renders a wide variety of biological data on relevant pathway graphs. All users need is to supply their data and specify the target pathway. This package automatically downloads the pathway graph data, parses the data file, maps user data to the pathway, and render pathway graph with the mapped data. In addition, r-pathview also seamlessly integrates with pathway and gene set (enrichment) analysis tools for large-scale and fully automated analysis.
This package allows for persistent storage, access, exploration, and manipulation of Cufflinks high-throughput sequencing data. In addition, provides numerous plotting functions for commonly used visualizations.
This package provides various wrapper functions that have been written to streamline the more common analyses that a Biostatistician might see.
With the dedicated fortify method implemented for flowSet, ncdfFlowSet and GatingSet classes, both raw and gated flow cytometry data can be plotted directly with ggplot. The ggcyto wrapper and some custom layers also make it easy to add gates and population statistics to the plot.