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.
BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.
LAMMPS is a classical molecular dynamics simulator designed to run efficiently on parallel computers. LAMMPS has potentials for solid-state materials (metals, semiconductors), soft matter (biomolecules, polymers), and coarse-grained or mesoscopic systems. It can be used to model atoms or, more generically, as a parallel particle simulator at the atomic, meso, or continuum scale.
Bamnostic is a pure Python Binary Alignment Map (BAM) file parser and random access tool.
This package provides the ASCAT R package that can be used to infer tumour purity, ploidy and allele-specific copy number profiles.
python-cwl-upgrader is a standalone upgrader for CWL documents from version draft-3, v1.0, and v1.1 to v1.2.
Smithlab CPP is a C++ library that includes functions used in many of the Smith lab bioinformatics projects, such as a wrapper around Samtools data structures, classes for genomic regions, mapped sequencing reads, etc.
VoltRon is a novel spatial omic analysis toolbox for multi-omics integration using spatial image registration. VoltRon is capable of analyzing multiple types and modalities of spatially-aware datasets. VoltRon visualizes and analyzes regions of interests (ROIs), spots, cells and even molecules.
The phylo module provides a biojava interface layer to the forester phylogenomics library for constructing phylogenetic trees.
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.
BioJava is a project dedicated to providing a Java framework for processing biological data. It provides analytical and statistical routines, parsers for common file formats, reference implementations of popular algorithms, and allows the manipulation of sequences and 3D structures. The goal of the biojava project is to facilitate rapid application development for bioinformatics.
This package provides the core libraries.
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.
This package provides data for the SeuratExtend tool.
This package generates a Miami plot with centered chromosome labels. The output is a ggplot2 object. Users can specify which data they want plotted on top vs. bottom, whether to display significance line(s), what colors to give chromosomes, and what points to label.
Skewer implements the bit-masked k-difference matching algorithm dedicated to the task of adapter trimming and it is specially designed for processing next-generation sequencing (NGS) paired-end sequences.
HOMER (Hypergeometric Optimization of Motif EnRichment) is a suite of tools for Motif Discovery and next-gen sequencing analysis. It is a collection of command line programs written in Perl and C++. HOMER was primarily written as a de novo motif discovery algorithm and is well suited for finding 8-20 bp motifs in large scale genomics data. HOMER contains many useful tools for analyzing ChIP-Seq, GRO-Seq, RNA-Seq, DNase-Seq, Hi-C and numerous other types of functional genomics sequencing data sets.
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.
BĂogo is a bioinformatics library for the Go language.
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 package offers a set of functions to use in order to compute communities on graphs weighted or unweighted.
BitMapperBS is memory-efficient aligner that is designed for whole-genome bisulfite sequencing (WGBS) reads from directional protocol.
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.
FLASH (Fast Length Adjustment of SHort reads) is a tool to merge paired-end reads from next-generation sequencing experiments. FLASH is designed to merge pairs of reads when the original DNA fragments are shorter than twice the length of reads. The resulting longer reads can significantly improve genome assemblies. They can also improve transcriptome assembly when FLASH is used to merge RNA-seq data.
python-gffutils is a Python package for working with and manipulating the GFF and GTF format files typically used for genomic annotations. The files are loaded into a SQLite database, allowing much more complex manipulation of hierarchical features (e.g., genes, transcripts, and exons) than is possible with plain-text methods alone.
This package provides Python bindings to the libBigWig library for accessing bigWig files.