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 atena package quantifies expression of TEs (transposable elements) from RNA-seq data through different methods, including ERVmap, TEtranscripts and Telescope. A common interface is provided to use each of these methods, which consists of building a parameter object, calling the quantification function with this object and getting a SummarizedExperiment object as an output container of the quantified expression profiles. The implementation allows quantifing TEs and gene transcripts in an integrated manner.
This package provides functions and datasets for maximum likelihood fitting of some classes of graphical Markov models.
This package provides full masked genome sequences for Drosophila melanogaster (Fly) as provided by UCSC (dm3, April 2006) and stored in Biostrings objects. The sequences are the same as in BSgenome.Dmelanogaster.UCSC.dm3, except that each of them has the 4 following masks on top: (1) the mask of assembly gaps (AGAPS mask), (2) the mask of intra-contig ambiguities (AMB mask), (3) the mask of repeats from RepeatMasker (RM mask), and (4) the mask of repeats from Tandem Repeats Finder (TRF mask). Only the AGAPS and AMB masks are "active" by default.
The package contains functions that can be used to compare expression measures for Affymetrix Oligonucleotide Arrays.
This package provides tools to acquire, annotate, convert and store data for use in Bioconductor’s AnnotationHub.
This package uses the source code of zlib-1.2.5 to create libraries for systems that do not have these available via other means.
This R/Bioconductor package provides an interface between HDF5 and R. HDF5's main features are the ability to store and access very large and/or complex datasets and a wide variety of metadata on mass storage (disk) through a completely portable file format. The rhdf5 package is thus suited for the exchange of large and/or complex datasets between R and other software package, and for letting R applications work on datasets that are larger than the available RAM.
This package provides functions to add metadata to ExperimentHub db and resource files to AWS S3 buckets.
This is a tool for human B-cell context-specific transcriptional regulatory network. In addition, this package provides a human normal B-cells dataset for the examples in package viper.
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.
Vizualize, analyze and explore networks using Cytoscape via R. Anything you can do using the graphical user interface of Cytoscape, you can now do with a single RCy3 function.
This package provides tools for discriminative motif discovery in high throughput genetic sequencing data sets using regression methods.
This package provides a collection of reference expression datasets with curated cell type labels, for use in procedures like automated annotation of single-cell data or deconvolution of bulk RNA-seq.
This package implements a new RNA-Seq analysis method and integrates two modules: a basic model for pairwise comparison and a linear model for complex design. RNA-Seq quantifies gene expression with reads count, which usually consists of conditions (or treatments) and several replicates for each condition. This software infers differential expression directly by the counts difference between conditions. It assumes that the sum counts difference between conditions follow a negative binomial distribution. In addition, ABSSeq moderates the fold-changes by two steps: the expression level and gene-specific dispersion, that might facilitate the gene ranking by fold-change and visualization.
This package provides tools for the identification of differentially expressed genes and estimation of the False Discovery Rate (FDR) using both the Significance Analysis of Microarrays (SAM) and the Empirical Bayes Analyses of Microarrays (EBAM).
This package provides functions to fit nonparametric survival curves, plot them, and perform logrank or Wilcoxon type tests.
This package provides a client for the Bioconductor AnnotationHub web resource. The AnnotationHub web resource provides a central location where genomic files (e.g. VCF, bed, wig) and other resources from standard locations (e.g. UCSC, Ensembl) can be discovered. The resource includes metadata about each resource, e.g., a textual description, tags, and date of modification. The client creates and manages a local cache of files retrieved by the user, helping with quick and reproducible access.
Skeletal myoblasts undergo a well-characterized sequence of morphological and transcriptional changes during differentiation. In this experiment, primary human skeletal muscle myoblasts (HSMM) were expanded under high mitogen conditions (GM) and then differentiated by switching to low-mitogen media (DM). RNA-Seq libraries were sequenced from each of several hundred cells taken over a time-course of serum-induced differentiation. Between 49 and 77 cells were captured at each of four time points (0, 24, 48, 72 hours) following serum switch using the Fluidigm C1 microfluidic system. RNA from each cell was isolated and used to construct mRNA-Seq libraries, which were then sequenced to a depth of ~4 million reads per library, resulting in a complete gene expression profile for each cell.
This is a package for saving Bioconductor data structures into file artifacts, and loading them back into memory. This is a more robust and 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 implements sampling, iteration, and input of FASTQ files. It includes functions for filtering and trimming reads, and for generating a quality assessment report. Data are represented as DNAStringSet-derived objects, and easily manipulated for a diversity of purposes. The package also contains legacy support for early single-end, ungapped alignment formats.
This package provides a library of core pre-processing and normalization routines.
This package defines data structures for linkage disequilibrium (LD) measures in populations. Its purpose is to simplify handling of existing population-level data for the purpose of flexibly defining LD blocks.
Principal Component Analysis (PCA) extracts the fundamental structure of the data without the need to build any model to represent it. This "summary" of the data is arrived at through a process of reduction that can transform the large number of variables into a lesser number that are uncorrelated (i.e. the 'principal components'), while at the same time being capable of easy interpretation on the original data. PCAtools provides functions for data exploration via PCA, and allows the user to generate publication-ready figures. PCA is performed via BiocSingular; users can also identify an optimal number of principal components via different metrics, such as the elbow method and Horn's parallel analysis, which has relevance for data reduction in single-cell RNA-seq (scRNA-seq) and high dimensional mass cytometry data.
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.