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.
Express Beta Diversity (EBD) calculates ecological beta diversity (dissimilarity) measures between biological communities. EBD implements a variety of diversity measures including those that make use of phylogenetic similarity of community members.
SeqAn is a C++ library of efficient algorithms and data structures for the analysis of sequences with the focus on biological data. It contains algorithms and data structures for string representation and their manipulation, online and indexed string search, efficient I/O of bioinformatics file formats, sequence alignment, and more.
This package provides a set of R functions to parse markdown and other generic helpers.
This package infers, visualizes and analyzes the cell-cell communication networks from scRNA-seq data.
FAN-C provides a pipeline for analysing Hi-C data starting at mapped paired-end sequencing reads.
Bio++ is a set of C++ libraries for Bioinformatics, including sequence analysis, phylogenetics, molecular evolution and population genetics. This library provides population genetics-related modules.
Pyani provides a package and script for calculation of genome-scale average nucleotide identity.
VSEARCH supports DNA sequence searching, clustering, chimera detection, dereplication, pairwise alignment, shuffling, subsampling, sorting and masking. The tool takes advantage of parallelism in the form of SIMD vectorization as well as multiple threads to perform accurate alignments at high speed. VSEARCH uses an optimal global aligner (full dynamic programming Needleman-Wunsch).
CodeAndRoll2 is a set of more than 130 productivity functions. These functions are used by MarkdownReports, ggExpress, and SeuratUtils.
Change-O is a collection of tools for processing the output of V(D)J alignment tools, assigning clonal clusters to immunoglobulin (Ig) sequences, and reconstructing germline sequences.
This package is a rasterization preprocessing framework that aggregates cellular information into spatial pixels to reduce resource requirements for spatial omics data analysis. SEraster reduces the number of points in spatial omics datasets for downstream analysis through a process of rasterization where single cells gene expression or cell-type labels are aggregated into equally sized pixels based on a user-defined resolution. SEraster can be incorporated with other packages to conduct downstream analyses for spatial omics datasets, such as detecting spatially variable genes.
This R package provides additional capabilities and speed for GenomicRanges operations.
LIANA provides a number of methods and resource for ligand-receptor interaction inference from scRNA-seq data.
This is a Ligand-Receptor inference framework. The framework enables the use of any LR method with any resources.
This package implements the custom CRAM codecs used for "EXTERNAL" block types. These consist of two variants of the rANS codec (8-bit and 16-bit renormalisation, with run-length encoding and bit-packing also supported in the latter), a dynamic arithmetic coder, and custom codecs for name/ID compression and quality score compression derived from fqzcomp.
The pbbam software package provides components to create, query, and edit PacBio BAM files and associated indices. These components include a core C++ library, bindings for additional languages, and command-line utilities. This library is not intended to be used as a general-purpose BAM utility - all input and output BAMs must adhere to the PacBio BAM format specification. Non-PacBio BAMs will cause exceptions to be thrown.
Bloom-filter-based error correction solution for high-throughput sequencing reads (BLESS) uses a single minimum-sized bloom filter is a correction tool for genomic reads produced by Next-generation sequencing (NGS). BLESS produces accurate correction results with much less memory compared with previous solutions and is also able to tolerate a higher false-positive rate. BLESS can extend reads like DNA assemblers to correct errors at the end of reads.
PSIplot is an R package for generating plots of percent spliced-in (PSI) values of alternatively-spliced exons that were computed by vast-tools, an RNA-Seq pipeline for alternative splicing analysis. The plots are generated using ggplot2.
This is a drop-in replacement for the IlluminaHumanMethylationEPIC package. It utilizes a Manifest based on 1.0B5 annotation. As of version 0.3.0, the IlluminaHumanMethylationEPIC package still employs the 1.0B2 annotation manifest. A corresponding annotation package, IlluminaHumanMethylationEPICanno.ilm10b5.hg38, is available to ensure proper annotation. The decision to maintain the same name is due to complications in downstream processing caused by array name lookup in certain preprocessing options.
Grouping large genomic fragments assembled from shotgun metagenomic sequences to deconvolute complex microbial communities, or metagenome binning, enables the study of individual organisms and their interactions. MetaBAT is an automated metagenome binning software, which integrates empirical probabilistic distances of genome abundance and tetranucleotide frequency.
Mudata is a Python package for multi-omics data analysis. It is designed to provide functionality to load, process, and store multimodal omics data.
CNVkit is a Python library and command-line software toolkit to infer and visualize copy number from high-throughput DNA sequencing data. It is designed for use with hybrid capture, including both whole-exome and custom target panels, and short-read sequencing platforms such as Illumina and Ion Torrent.
Sleuth is a program for differential analysis of RNA-Seq data. It makes use of quantification uncertainty estimates obtained via Kallisto for accurate differential analysis of isoforms or genes, allows testing in the context of experiments with complex designs, and supports interactive exploratory data analysis via sleuth live.
Bioinformaticians often have to convert sequence files between formats and do little manipulations on them, and it's not worth writing scripts for that. Seqmagick is a utility to expose the file format conversion in BioPython in a convenient way. Instead of having a big mess of scripts, there is one that takes arguments.