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 khmer software is a set of command-line tools for working with DNA shotgun sequencing data from genomes, transcriptomes, metagenomes and single cells. Khmer can make de novo assemblies faster, and sometimes better. Khmer can also identify and fix problems with shotgun data.
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.
BEDOPS is a suite of tools to address common questions raised in genomic studies---mostly with regard to overlap and proximity relationships between data sets. It aims to be scalable and flexible, facilitating the efficient and accurate analysis and management of large-scale genomic data.
BEDOPS provides tools that perform highly efficient and scalable Boolean and other set operations, statistical calculations, archiving, conversion and other management of genomic data of arbitrary scale. Tasks can be easily split by chromosome for distributing whole-genome analyses across a computational cluster.
PAIRADISE is a method for detecting allele-specific alternative splicing (ASAS) from RNA-seq data. Unlike conventional approaches that detect ASAS events one sample at a time, PAIRADISE aggregates ASAS signals across multiple individuals in a population. By treating the two alleles of an individual as paired, and multiple individuals sharing a heterozygous SNP as replicates, PAIRADISE formulates ASAS detection as a statistical problem for identifying differential alternative splicing from RNA-seq data with paired replicates.
This is a collection of functions created and/or curated to aid in the visualization and analysis of single-cell data using R.
MAFFT offers a range of multiple alignment methods for nucleotide and protein sequences. For instance, it offers L-INS-i (accurate; for alignment of <~200 sequences) and FFT-NS-2 (fast; for alignment of <~30,000 sequences).
SCENIC (Single-cell regulatory network inference and clustering) is an R package to infer Gene Regulatory Networks and cell types from single-cell RNA-seq data.
This package provides the kentUtils, a selection of bioinformatics utilities used in combination with the UCSC genome browser.
Salmon is a program to produce highly-accurate, transcript-level quantification estimates from RNA-seq data. Salmon achieves its accuracy and speed via a number of different innovations, including the use of lightweight alignments (accurate but fast-to-compute proxies for traditional read alignments) and massively-parallel stochastic collapsed variational inference.
BioPerl is the product of a community effort to produce Perl code which is useful in biology. Examples include Sequence objects, Alignment objects and database searching objects. These objects not only do what they are advertised to do in the documentation, but they also interact - Alignment objects are made from the Sequence objects, Sequence objects have access to Annotation and SeqFeature objects and databases, Blast objects can be converted to Alignment objects, and so on. This means that the objects provide a coordinated and extensible framework to do computational biology.
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).
Mudskipper is a tool for projecting genomic alignments to transcriptomic coordinates.
CIRI-long is a package for circular RNA identification using long-read sequencing data.
Sjcount is a utility for fast quantification of splice junctions in RNA-seq data. It is annotation-agnostic and offset-aware. This version does count multisplits.
This package provides TagGD barcode demultiplexing utilities for Spatial Transcriptomics data.
BitMapperBS is memory-efficient aligner that is designed for whole-genome bisulfite sequencing (WGBS) reads from directional protocol.
This package stores motif collections as lists of position frequency matrix (PWMatrixList) objects provided by the TFBSTools package for use in R with packages like motifmatchr or chromVAR.
This package provides a tool for identifying and removing doublets in single-cell RNA-seq data.
bustools is a program for manipulating BUS files for single cell RNA-Seq datasets. It can be used to error correct barcodes, collapse UMIs, produce gene count or transcript compatibility count matrices, and is useful for many other tasks.
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.
Flexbar preprocesses high-throughput nucleotide sequencing data efficiently. It demultiplexes barcoded runs and removes adapter sequences. Moreover, trimming and filtering features are provided. Flexbar increases read mapping rates and improves genome and transcriptome assemblies. It supports next-generation sequencing data in fasta/q and csfasta/q format from Illumina, Roche 454, and the SOLiD platform.
Straw is library which allows rapid streaming of contact data from .hic files. This package provides Python bindings.
Bowtie 2 is a fast and memory-efficient tool for aligning sequencing reads to long reference sequences. It is particularly good at aligning reads of about 50 up to 100s or 1,000s of characters, and particularly good at aligning to relatively long (e.g. mammalian) genomes. Bowtie 2 indexes the genome with an FM Index to keep its memory footprint small: for the human genome, its memory footprint is typically around 3.2 GB. Bowtie 2 supports gapped, local, and paired-end alignment modes.
Collectively, the bedtools utilities are a swiss-army knife of tools for a wide-range of genomics analysis tasks. The most widely-used tools enable genome arithmetic: that is, set theory on the genome. For example, bedtools allows one to intersect, merge, count, complement, and shuffle genomic intervals from multiple files in widely-used genomic file formats such as BAM, BED, GFF/GTF, VCF.