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.
Fastahack is a small application for indexing and extracting sequences and subsequences from FASTA files. The included library provides a FASTA reader and indexer that can be embedded into applications which would benefit from directly reading subsequences from FASTA files. The library automatically handles index file generation and use.
The goal of bedtorch is to provide a fast BED file manipulation tool suite native in R.
Presto is a python toolkit for processing raw reads from high-throughput sequencing of B cell and T cell repertoires.
This is a Perl interface to the HTS library for DNA sequencing.
This package provides an implementation of chunked, compressed, N-dimensional arrays for R, Zarr specification version 2 (2024) <doi:10.5281/zenodo.11320255>.
This package provides a deconvolution based on Single Nucleotide Position (SNP) for multiplexed scRNA-seq data. The name vireo stand for Variational Inference for Reconstructing Ensemble Origin by expressed SNPs in multiplexed scRNA-seq data and follows the clone identification from single-cell data named cardelino.
MOSAIK is a program for mapping second and third-generation sequencing reads to a reference genome. MOSAIK can align reads generated by all the major sequencing technologies, including Illumina, Applied Biosystems SOLiD, Roche 454, Ion Torrent and Pacific BioSciences SMRT.
This package implements parallel block gzip. For many formats, in particular genomics data formats, data are compressed in fixed-length blocks such that they can be easily indexed based on a (genomic) coordinate order, since typically each block is sorted according to this order. This allows for each block to be individually compressed (deflated), or more importantly, decompressed (inflated), with the latter enabling random retrieval of data in large files (gigabytes to terabytes). pbgzip is not limited to any particular format, but certain features are tailored to genomics data formats when enabled. Parallel decompression is somewhat faster, but the true speedup comes during compression.
CrossMap is a program for conversion of genome coordinates or annotation files between different genome assemblies. It supports most commonly used file formats including SAM/BAM, Wiggle/BigWig, BED, GFF/GTF, VCF.
This package Copynumber KAryotyping of Tumors infers genomic copy number and subclonal structure of human tumors using integrative Bayesian approaches to identify genome-wide aneuploidy at 5MB resolution in single cells data. It separates tumor cells and tumor subclones from normal cells using high-throughput sc-RNAseq 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.
Pegasusio is a Python package for reading or writing single-cell genomics data.
Bio::Kseq provides ruby bindings to the kseq.h FASTA and FASTQ parsing code. It provides a fast iterator over sequences and their quality scores.
This package provides data structures, algorithms and educational resources for bioinformatics.
The wavefront alignment (WFA) algorithm is an exact gap-affine algorithm that takes advantage of homologous regions between the sequences to accelerate the alignment process.
This program compares version strings. It intends to be a replacement for strverscmp.
Fluff is a Python package that contains several scripts to produce pretty, publication-quality figures for next-generation sequencing experiments.
This is a set of functions for processing raw scDam&T-seq data. scDam&T-seq is a method to simultaneously measure protein-DNA interactions and transcription from single cells (Rooijers et al., 2019). It combines a DamID-based method to measure protein-DNA interactions and an adaptation of CEL-Seq to measure transcription. The starting point of the workflow is raw sequencing data and the end result are tables of UMI-unique DamID and CEL-Seq counts.
PHYLIP (the PHYLogeny Inference Package) is a package of programs for inferring phylogenies (evolutionary trees).
DIAMOND is a BLAST-compatible local aligner for mapping protein and translated DNA query sequences against a protein reference database (BLASTP and BLASTX alignment mode). The speedup over BLAST is up to 20,000 on short reads at a typical sensitivity of 90-99% relative to BLAST depending on the data and settings.
Pando leverages multi-modal single-cell measurements to infer gene regulatory networks using a flexible linear model-based framework. By modeling the relationship between TF-binding site pairs with the expression of target genes, Pando simultaneously infers gene modules and sets of regulatory regions for each transcription factor.
PiGx SARS-CoV-2 is a pipeline for analysing data from sequenced wastewater samples and identifying given variants-of-concern of SARS-CoV-2. The pipeline can be used for continuous sampling. The output report will provide an intuitive visual overview about the development of variant abundance over time and location.
MultiVelo uses a probabilistic latent variable model to estimate the switch time and rate parameters of gene regulation, providing a quantitative summary of the temporal relationship between epigenomic and transcriptomic changes.
This package provides R miscellaneous utilities for basic data manipulation, debugging, visualization, lsf management, and common mskilab tasks.