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.
This package provides basic plotting, data manipulation and processing of mass spectrometry based proteomics data.
This R package enables the user to read pfam predictions into R. Most human protein domains exist as multiple distinct variants termed domain isotypes. This R package enables the identification and classification of such domain isotypes from pfam data.
This is a package for the automated analysis of Affymetrix arrays. It is used for preprocessing the arrays.
This package provides functions for annotation-agnostic differential expression analysis of RNA-seq data. Two implementations of the DER Finder approach are included in this package:
single base-level F-statistics and
DER identification at the expressed regions-level.
The DER Finder approach can also be used to identify differentially bounded ChIP-seq peaks.
This package provides a framework to perform Non-negative Matrix Factorization (NMF). The package implements a set of already published algorithms and seeding methods, and provides a framework to test, develop and plug new or custom algorithms. Most of the built-in algorithms have been optimized in C++, and the main interface function provides an easy way of performing parallel computations on multicore machines.
The package alpine helps to model bias parameters and then using those parameters to estimate RNA-seq transcript abundance. Alpine is a package for estimating and visualizing many forms of sample-specific biases that can arise in RNA-seq, including fragment length distribution, positional bias on the transcript, read start bias (random hexamer priming), and fragment GC-content (amplification). It also offers bias-corrected estimates of transcript abundance in FPKM(Fragments Per Kilobase of transcript per Million mapped reads). It is currently designed for un-stranded paired-end RNA-seq data.
The ASAFE package contains a collection of functions that can be used to carry out an EM (Expectation–maximization) algorithm to estimate ancestry-specific allele frequencies for a bi-allelic genetic marker, e.g. an SNP (single nucleotide polymorphism) from genotypes and ancestry pairs.
This package infers and discriminates RIP peaks from RIP-seq alignments using two-state HMM with negative binomial emission probability. While RIPSeeker is specifically tailored for RIP-seq data analysis, it also provides a suite of bioinformatics tools integrated within this self-contained software package comprehensively addressing issues ranging from post-alignments processing to visualization and annotation.
This is the classification package for the automated analysis of Affymetrix arrays.
This package provides S4 generic functions needed by Bioconductor proteomics packages.
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.
This package is used to detect combination of genomic coordinates falling within a user defined window size along with user defined overlap between identified neighboring clusters. It can be used for genomic data where the clusters are built on a specific chromosome or specific strand. Clustering can be performed with a "greedy" option allowing thus the presence of additional sites within the allowed window size.
This package provides tools to create and plot diffusion maps.
This package provides a toolset for deciphering and managing biological sequences.
This package provides functions to ease the transition between Rmarkdown and LaTeX documents when authoring a Bioconductor Workflow.
This package provides functions for the integrated analysis of protein-protein interaction networks and the detection of functional modules. Different datasets can be integrated into the network by assigning p-values of statistical tests to the nodes of the network. E.g. p-values obtained from the differential expression of the genes from an Affymetrix array are assigned to the nodes of the network. By fitting a beta-uniform mixture model and calculating scores from the p-values, overall scores of network regions can be calculated and an integer linear programming algorithm identifies the maximum scoring subnetwork.
R-escape streamlines gene set enrichment analysis for single-cell RNA sequencing. Using raw count information, Seurat objects, or SingleCellExperiment format, users can perform and visualize GSEA across individual cells.
This package provides the lengths of mRNA transcripts for a number of genomes and gene ID formats, largely based on the UCSC table browser.
In order to assess the quality of a set of predicted genes for a genome, evidence must first be mapped to that genome. Next, each gene must be categorized based on how strong the evidence is for or against that gene. The AssessORF package provides the functions and class structures necessary for accomplishing those tasks, using proteomics hits and evolutionarily conserved start codons as the forms of evidence.
This package exposes an annotation databases generated from UCSC by exposing these as TxDb objects.
This package provides a collection of functions designed for analyzing deconvolution of the bulk sample(s) using an atlas of reference omic signature profiles and a user-selected model. Users are given the option to create or extend a reference atlas and,also simulate the desired size of the bulk signature profile of the reference cell types. The package includes the cell-type-specific methylation atlas and, Illumina Epic B5 probe ids that can be used in deconvolution. Additionally, we included BSmeth2Probe, to make mapping WGBS data to their probe IDs easier.
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.
The Triform algorithm uses model-free statistics to identify peak-like distributions of TF ChIP sequencing reads, taking advantage of an improved peak definition in combination with known profile characteristics.
Saves the delayed operations of a DelayedArray to a HDF5 file. This enables efficient recovery of the DelayedArray's contents in other languages and analysis frameworks.