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 supports the computation of an F-test for the association between expression values and clinical entities. In many cases a two way layout with gene and a dichotomous group as factors will be considered. However, adjustment for other covariates and the analysis of arbitrary clinical variables, interactions, gene co-expression, time series data and so on is also possible. The test is carried out by comparison of corresponding linear models via the extra sum of squares principle.
This package wires together large collections of single-cell RNA-seq datasets, which allows for both the identification of recurrent cell clusters and the propagation of information between datasets in multi-sample or atlas-scale collections. Conos focuses on the uniform mapping of homologous cell types across heterogeneous sample collections. For instance, users could investigate a collection of dozens of peripheral blood samples from cancer patients combined with dozens of controls, which perhaps includes samples of a related tissue such as lymph nodes.
This package provides methods and models for handling zero-inflated single cell assay data.
This package provides a manifest package for Illumina's EPIC v2.0 methylation arrays. The version 2 covers more than 935K CpG sites in the human genome hg38. It is an update of the original EPIC v1.0 array (i.e., the 850K methylation array).
This R package provides tools for building and running automated end-to-end analysis workflows for a wide range of next generation sequence (NGS) applications such as RNA-Seq, ChIP-Seq, VAR-Seq and Ribo-Seq. Important features include a uniform workflow interface across different NGS applications, automated report generation, and support for running both R and command-line software, such as NGS aligners or peak/variant callers, on local computers or compute clusters. Efficient handling of complex sample sets and experimental designs is facilitated by a consistently implemented sample annotation infrastructure.
Expression levels of mRNA molecules are regulated by different processes, comprising inhibition or activation by transcription factors and post-transcriptional degradation by microRNAs. birta (Bayesian Inference of Regulation of Transcriptional Activity) uses the regulatory networks of transcription factors and miRNAs together with mRNA and miRNA expression data to predict switches in regulatory activity between two conditions. A Bayesian network is used to model the regulatory structure and Markov-Chain-Monte-Carlo is applied to sample the activity states.
This is a package for de novo identification and extraction of differentially methylated regions (DMRs) from the human genome using Whole Genome Bisulfite Sequencing (WGBS) and Illumina Infinium Array (450K and EPIC) data. It provides functionality for filtering probes possibly confounded by SNPs and cross-hybridisation. It includes GRanges generation and plotting functions.
This package provides an implementation of an algorithm for determining cluster count and membership by stability evidence in unsupervised analysis.
This package provides visualization tools for flow cytometry data.
This package provides the headers and static library of Protocol buffers for other R packages to compile and link against.
This package provides functions to detect and correct for batch effects in DNA methylation data. The core function is based on latent factor models and can also be used to predict missing values in any other matrix containing real numbers.
This package creates karyotype plots of arbitrary genomes and offers a complete set of functions to plot arbitrary data on them. It mimics many R base graphics functions coupling them with a coordinate change function automatically mapping the chromosome and data coordinates into the plot coordinates.
This package provides a suite of helper functions for checking and manipulating TCGA data including data obtained from the curatedTCGAData experiment package. These functions aim to simplify and make working with TCGA data more manageable. Exported functions include those that import data from flat files into Bioconductor objects, convert row annotations, and identifier translation via the GDC API.
This package provides tools to acquire, annotate, convert and store data for use in Bioconductor’s AnnotationHub.
This package provides Ion Trap positive ionization mode data in mzML file format. It includes a subset from 500-850 m/z and 1190-1310 seconds, including MS2 and MS3, intensity threshold 100.000; extracts from FTICR Apex III, m/z 400-450; a subset of UPLC - Bruker micrOTOFq data, both mzML and mz5; LC-MSMS and MRM files from proteomics experiments; and PSI mzIdentML example files for various search engines.
This package provides Escherichia coli full genomes for several strains as provided by NCBI on 2008/08/05 and stored in Biostrings objects.
The SparseArray package is an infrastructure package that provides an array-like container for efficient in-memory representation of multidimensional sparse data in R. The package defines the SparseArray virtual class and two concrete subclasses: COO_SparseArray and SVT_SparseArray. Each subclass uses its own internal representation of the nonzero multidimensional data, the "COO layout" and the "SVT layout", respectively. SVT_SparseArray objects mimic as much as possible the behavior of ordinary matrix and array objects in base R. In particular, they support most of the "standard matrix and array API" defined in base R and in the matrixStats package from CRAN.
This package provides methods for visualizing large multivariate datasets using static and interactive scatterplot matrices, parallel coordinate plots, volcano plots, and litre plots. It includes examples for visualizing RNA-sequencing datasets and differentially expressed genes.
The anota2seq package provides analysis of translational efficiency and differential expression analysis for polysome-profiling and ribosome-profiling studies (two or more sample classes) quantified by RNA sequencing or DNA-microarray. Polysome-profiling and ribosome-profiling typically generate data for two RNA sources, translated mRNA and total mRNA. Analysis of differential expression is used to estimate changes within each RNA source. Analysis of translational efficiency aims to identify changes in translation efficiency leading to altered protein levels that are independent of total mRNA levels or buffering, a mechanism regulating translational efficiency so that protein levels remain constant despite fluctuating total mRNA levels.
This package implements `import()` and `export()` standard generics for importing and exporting biological data formats. `import()` supports whole-file as well as chunk-wise iterative import. The `import()` interface optionally provides a standard mechanism for 'lazy' access via `filter()` (on row or element-like components of the file resource), `select()` (on column-like components of the file resource) and `collect()`. The `import()` interface optionally provides transparent access to remote (e.g. via https) as well as local access. Developers can register a file extension, e.g., `.loom` for dispatch from character-based URIs to specific `import()` / `export()` methods based on classes representing file types, e.g., `LoomFile()`.
This package provides utilities for flow cytometry data.
This package provides tools to display a rectangular heatmap (intensity plot) of a data matrix. By default, both samples (columns) and features (row) of the matrix are sorted according to a hierarchical clustering, and the corresponding dendrogram is plotted. Optionally, panels with additional information about samples and features can be added to the plot.
This package provides an interactive tool for visualizing Illumina methylation array data. Both the 450k and EPIC array are supported.
This package provides an alternative interface to Bioconductor annotation resources, in particular the gene identifier mapping functionality of the org packages (e.g., org.Hs.eg.db) and the genome coordinate functionality of the TxDb packages (e.g., TxDb.Hsapiens.UCSC.hg38.knownGene).