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.
Fastseg implements a very fast and efficient segmentation algorithm. It can segment data from DNA microarrays and data from next generation sequencing for example to detect copy number segments. Further it can segment data from RNA microarrays like tiling arrays to identify transcripts. Most generally, it can segment data given as a matrix or as a vector. Various data formats can be used as input to fastseg like expression set objects for microarrays or GRanges for sequencing data.
The scDblFinder package gathers various methods for the detection and handling of doublets/multiplets in single-cell RNA sequencing data (i.e. multiple cells captured within the same droplet or reaction volume). It includes methods formerly found in the scran package, and the new fast and comprehensive scDblFinder method.
This is a package for saving GenomicRanges, IRanges and related data structures into file artifacts, and loading them back into memory. This is a more portable alternative to serialization of such objects into RDS files. Each artifact is associated with metadata for further interpretation; downstream applications can enrich this metadata with context-specific properties.
This package extends beachmat to support initialization of tatami matrices from HDF5-backed arrays. This allows C++ code in downstream packages to directly call the HDF5 C/C++ library to access array data, without the need for block processing via DelayedArray. Some utilities are also provided for direct creation of an in-memory tatami matrix from a HDF5 file.
This package provides tools for normalizing and analyzing of GeneChip Mapping 100K and 500K Set. Affymetrix GeneChip Human Mapping 100K and 500K Set allows the DNA copy number mea- surement of respectively 2× 50K and 2× 250K SNPs along the genome. Their high density allows a precise localization of genomic alterations and makes them a powerful tool for cancer and copy number polymorphism study.
This is a package for identification of metabolites using high precision mass spectrometry. MS peaks are used to derive a ranked list of sum formulae, alternatively for a given sum formula the theoretical isotope distribution can be calculated to search in MS peak lists.
The package detects extended diffuse and compact blemishes on microarray chips. Harshlight marks the areas in a collection of chips (affybatch objects). A corrected AffyBatch object will result. The package replaces the defected areas with N/As or the median of the values of the same probe. The new version handles the substitute value as a whole matrix to solve the memory problem.
This is a package for the analysis of alternative splicing and isoform switches with predicted functional consequences (e.g. gain/loss of protein domains etc.) from quantification of all types of RNASeq by tools such as Kallisto, Salmon, StringTie, Cufflinks/Cuffdiff etc.
This package can be used to test two sets of gene lists and visualize the results.
This package provides classes and other infrastructure to implement filters for manipulating Bioconductor annotation resources. The filters are used by ensembldb, Organism.dplyr, and other packages.
This package provides a model for the clone size distribution of the TCR repertoire. Further, it permits comparative analysis of TCR repertoire libraries based on theoretical model fits.
The enrichplot package implements several visualization methods for interpreting functional enrichment results obtained from ORA or GSEA analyses. All the visualization methods are developed based on ggplot2 graphics.
The AffiXcan package imputes a genetically regulated expression (GReX) for a set of genes in a sample of individuals, using a method based on the total binding affinity (TBA). Statistical models to impute GReX can be trained with a training dataset where the real total expression values are known.
This package provides example datasets that represent 'real world examples' of Affymetrix data, unlike the artificial examples included in the package affy.
This package speeds up the derfinder package when using multiple cores. It is particularly useful when using BiocParallel and it helps reduce the time spent loading the full derfinder package when running the F-statistics calculation in parallel.
This package provides an integrated web interface for doing microarray analysis using several of the Bioconductor packages. It is intended to be deployed as a centralized bioinformatics resource for use by many users. Currently only Affymetrix oligonucleotide analysis is supported.
This package provides functions to plot data associated with arbitrary genomic intervals along chromosomal ideogram.
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 package provides a package containing an environment representing the HG_U95Av2.CDF file.
This is a package to support identification of markers of rare cell types by looking at genes whose expression is confined in small regions of the expression space.
This package is an R implementation for fully unsupervised deconvolution of complex tissues. DebCAM provides basic functions to perform unsupervised deconvolution on mixture expression profiles by CAM and some auxiliary functions to help understand the subpopulation- specific results. It also implements functions to perform supervised deconvolution based on prior knowledge of molecular markers, S matrix or A matrix. Combining molecular markers from CAM and from prior knowledge can achieve semi-supervised deconvolution of mixtures.
The package r-alevinqc generates quality control reports summarizing the output from an alevin run. The reports can be generated as HTML or PDF files, or as Shiny applications.
This package provides genome wide annotation for Yeast, primarily based on mapping using ORF identifiers from SGD.
This package implements different performance measures for classification and ranking tasks. Area under curve (AUC), precision at a given recall, F-score for single and multiple classes are available.