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.
This package provides bioinformatic tools to align, deduplicate, reformat, filter and normalize DNA and RNA-seq data. It includes the following tools: BBMap, a short read aligner for DNA and RNA-seq data; BBNorm, a kmer-based error-correction and normalization tool; Dedupe, a tool to simplify assemblies by removing duplicate or contained subsequences that share a target percent identity; Reformat, to convert reads between fasta/fastq/scarf/fasta+qual/sam, interleaved/paired, and ASCII-33/64, at over 500 MB/s; and BBDuk, a tool to filter, trim, or mask reads with kmer matches to an artifact/contaminant file.
Mantis is a space-efficient data structure that can be used to index thousands of raw-read genomics experiments and facilitate large-scale sequence searches on those experiments. Mantis uses counting quotient filters instead of Bloom filters, enabling rapid index builds and queries, small indexes, and exact results, i.e., no false positives or negatives. Furthermore, Mantis is also a colored de Bruijn graph representation, so it supports fast graph traversal and other topological analyses in addition to large-scale sequence-level searches.
Picard is a set of Java command line tools for manipulating high-throughput sequencing (HTS) data and formats. Picard is implemented using the HTSJDK Java library to support accessing file formats that are commonly used for high-throughput sequencing data such as SAM, BAM, CRAM and VCF.
Sailfish is a tool for genomic transcript quantification from RNA-seq data. It requires a set of target transcripts (either from a reference or de-novo assembly) to quantify. All you need to run sailfish is a fasta file containing your reference transcripts and a (set of) fasta/fastq file(s) containing your reads.
Delly is an integrated structural variant prediction method that can discover and genotype deletions, tandem duplications, inversions and translocations at single-nucleotide resolution in short-read massively parallel sequencing data. It uses paired-ends and split-reads to sensitively and accurately delineate genomic rearrangements throughout the genome.
Ngesh is a Python library and CLI tool for simulating phylogenetic trees and data. It is intended for benchmarking phylogenetic methods, especially in historical linguistics andstemmatology. The generation of stochastic phylogenetic trees also goes by the name simulationmethods for phylogenetic trees, synthetic data generation, or just phylogenetic tree simulation.
This package provides a Python package for reading raw fcs files
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.
EMBOSS is the "European Molecular Biology Open Software Suite". EMBOSS is an analysis package specially developed for the needs of the molecular biology (e.g. EMBnet) user community. The software automatically copes with data in a variety of formats and even allows transparent retrieval of sequence data from the web. It also provides a number of libraries for the development of software in the field of molecular biology. EMBOSS also integrates a range of currently available packages and tools for sequence analysis into a seamless whole.
Hclust2 is a handy tool for plotting heat-maps with several useful options to produce high quality figures that can be used in publications.
This is a package for the discovery of communities in Pore-C concatemers.
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.
Jellyfish is a tool for fast, memory-efficient counting of k-mers in DNA. A k-mer is a substring of length k, and counting the occurrences of all such substrings is a central step in many analyses of DNA sequence. Jellyfish is a command-line program that reads FASTA and multi-FASTA files containing DNA sequences. It outputs its k-mer counts in a binary format, which can be translated into a human-readable text format using the jellyfish dump command, or queried for specific k-mers with jellyfish query.
This package offers a flexible statistical simulator for scRNA-seq data. It can generate data that captures gene correlation. Additionally, it allows for varying the number of cells and sequencing depth.
This package is designed to improve and simplify the analysis of scRNA-seq data. It uses the Seurat object for this purpose. It provides an array of enhanced visualization tools, an integrated functional and pathway analysis pipeline, seamless integration with popular Python tools, and a suite of utility functions to aid in data manipulation and presentation.
Anglemania extracts genes from multi-batch scRNA-seq experiments for downstream dataset integration. It improves conventional usage of highly-variable genes for integration tasks.
ReadWriter is a set of R functions to read and write files conveniently.
This is a Python package for the interactive visualization of bulk RNA-seq data. It provides a range of plotting functions and interactive tools to explore and analyze bulk RNA-seq data.
Roary is a high speed stand alone pan genome pipeline, which takes annotated assemblies in GFF3 format (produced by the Prokka program) and calculates the pan genome. Using a standard desktop PC, it can analyse datasets with thousands of samples, without compromising the quality of the results. 128 samples can be analysed in under 1 hour using 1 GB of RAM and a single processor. Roary is not intended for metagenomics or for comparing extremely diverse sets of genomes.
bx-python provides tools for manipulating biological data, particularly multiple sequence alignments.
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.
Chromap is a fast method for aligning and preprocessing high throughput chromatin profiles. Typical use cases include:
trimming sequencing adapters, mapping bulk ATAC-seq or ChIP-seq genomic reads to the human genome and removing duplicates;
trimming sequencing adapters, mapping single cell ATAC-seq genomic reads to the human genome, correcting barcodes, removing duplicates and performing Tn5 shift;
split alignment of Hi-C reads against a reference genome.
Velvet is a de novo genomic assembler specially designed for short read sequencing technologies, such as Solexa or 454. Velvet currently takes in short read sequences, removes errors then produces high quality unique contigs. It then uses paired read information, if available, to retrieve the repeated areas between contigs.
Infernal ("INFERence of RNA ALignment") is a tool for searching DNA sequence databases for RNA structure and sequence similarities. It is an implementation of a special case of profile stochastic context-free grammars called covariance models (CMs). A CM is like a sequence profile, but it scores a combination of sequence consensus and RNA secondary structure consensus, so in many cases, it is more capable of identifying RNA homologs that conserve their secondary structure more than their primary sequence.