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 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.
r-circrnaprofiler is a computational framework for a comprehensive in silico analysis of circular RNA (circRNAs). This computational framework allows combining and analyzing circRNAs previously detected by multiple publicly available annotation-based circRNA detection tools. It covers different aspects of circRNAs analysis from differential expression analysis, evolutionary conservation, biogenesis to functional analysis.
This is a package providing tools to quantify and interpret multiple sources of biological and technical variation in gene expression experiments. It uses a linear mixed model to quantify variation in gene expression attributable to individual, tissue, time point, or technical variables. The package includes dream differential expression analysis for repeated measures.
This package provides an interface to the samtools, bcftools, and tabix utilities for manipulating SAM (Sequence Alignment / Map), FASTA, binary variant call (BCF) and compressed indexed tab-delimited (tabix) files.
DSS is an R library performing differential analysis for count-based sequencing data. It detects differentially expressed genes (DEGs) from RNA-seq, and differentially methylated loci or regions (DML/DMRs) from bisulfite sequencing (BS-seq). The core of DSS is a dispersion shrinkage method for estimating the dispersion parameter from Gamma-Poisson or Beta-Binomial distributions.
This package provides a database of PolyPhen predictions for Homo sapiens dbSNP build 131.
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 with metadata for genotyping Illumina 370k arrays using the crlmm package.
This package provides tools for discriminative motif discovery in high throughput genetic sequencing data sets using regression methods.
This package provides an annotation database of Homo sapiens genome data. It is derived from the UCSC hg38 genome and based on the "knownGene" track. The database is exposed as a TxDb object.
This package supports the application of diverse quality metrics to AffyBatch instances, summarizing these metrics via PCA, and then performing parametric outlier detection on the PCs to identify aberrant arrays with a fixed Type I error rate.
Enriched heatmap is a special type of heatmap which visualizes the enrichment of genomic signals on specific target regions. This type of heatmap is just a normal heatmap but with some special settings, with the functionality of ComplexHeatmap, it would be much easier to customize the heatmap as well as concatenating to a list of heatmaps to show correspondence between different data sources.
This package provides fast maximum-likelihood phylogeny inference from noisy single-cell data using the ScisTree algorithm proposed by doi.org/10.1093/bioinformatics/btz676, Yufeng Wu (2019). It makes the method applicable to massive single-cell datasets (>10,000 cells).
The biodb package provides access to standard remote chemical and biological databases (ChEBI, KEGG, HMDB, ...), as well as to in-house local database files (CSV, SQLite), with easy retrieval of entries, access to web services, search of compounds by mass and/or name, and mass spectra matching for LCMS and MSMS. Its architecture as a development framework facilitates the development of new database connectors for local projects or inside separate published packages.
This is an R package for doublet annotation of single cell RNA sequencing data. scds provides methods to annotate doublets in scRNA-seq data computationally.
This package provides a number of utility functions for handling single-cell RNA-seq data from droplet technologies such as 10X Genomics. This includes data loading from count matrices or molecule information files, identification of cells from empty droplets, removal of barcode-swapped pseudo-cells, and downsampling of the count matrix.
This package was derived from Rsymphony. The package provides an R interface to SYMPHONY, a linear programming solver written in C++. The main difference between this package and Rsymphony is that it includes the solver source code, while Rsymphony expects to find header and library files on the users' system. Thus the intention of lpsymphony is to provide an easy to install interface to SYMPHONY.
BAnOCC is a package designed for compositional data, where each sample sums to one. It infers the approximate covariance of the unconstrained data using a Bayesian model coded with rstan. It provides as output the stanfit object as well as posterior median and credible interval estimates for each correlation element.
This package contains reads from an RNA-seq experiment between two lung cancer cell lines: H1993 (met) and H2073 (primary). The reads are stored as Fastq files and are meant for use with the TP53Genome object in the gmapR package.
This package provides tools for analyzing R expressions or blocks of code and determining the dependencies between them. It focuses on R scripts, but can be used on the bodies of functions. There are many facilities including the ability to summarize or get a high-level view of code, determining dependencies between variables, code improvement suggestions.
MetaboCoreUtils defines metabolomics-related core functionality provided as low-level functions to allow a data structure-independent usage across various R packages. This includes functions to calculate between ion (adduct) and compound mass-to-charge ratios and masses or functions to work with chemical formulas. The package provides also a set of adduct definitions and information on some commercially available internal standard mixes commonly used in MS experiments.
This package generates microarray quality metrics reports for data in Bioconductor microarray data containers (ExpressionSet, NChannelSet, AffyBatch). One and two color array platforms are supported.
The genome is divided into non-overlapping fixed-sized bins, number of sequence reads in each counted, adjusted with a simultaneous two-dimensional loess correction for sequence mappability and GC content, and filtered to remove spurious regions in the genome. Downstream steps of segmentation and calling are also implemented via packages DNAcopy and CGHcall, respectively.
ChemmineOB provides an R interface to a subset of cheminformatics functionalities implemented by the OpelBabel C++ project. OpenBabel is a free cheminformatics toolbox that includes utilities for structure format interconversions, descriptor calculations, compound similarity searching and more. ChemineOB aims to make a subset of these utilities available from within R. For non-developers, ChemineOB is primarily intended to be used from ChemmineR as an add-on package rather than used directly.