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.
Azimuth utilizes an annotated reference dataset. It automates the processing, analysis, and interpretation. This applies specifically to new single-cell RNA-seq or ATAC-seq experiments. Azimuth leverages a reference-based mapping pipeline that inputs accounts matrix and performs normalization, visualization, cell annotation, and differential expression.
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.
Megahit is a fast and memory-efficient NGS assembler. It is optimized for metagenomes, but also works well on generic single genome assembly (small or mammalian size) and single-cell assembly.
This package implements the method csSAM that computes cell-specific differential expression from measured cell proportions using SAM.
This package lets you perform unsupervised clustering of amplicon sequencing data in microbiome studies with the Dirichlet-tree Multinomial Mixtures.
The alignment module of BioJava provides an API that contains
implementations of dynamic programming algorithms for sequence alignment;
reading and writing of popular alignment file formats;
a single-, or multi- threaded multiple sequence alignment algorithm.
This package provides a robust, parallelized Python CLI for annotating three prime UTR.
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.
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.
This package implements a bioinformatics algorithm for demultiplexing multiplexed single cell datasets. It is built on a statistical model of tag read counts derived from the physical mechanism of tag cross-contamination.
VBZ Compression uses variable byte integer encoding to compress nanopore signal data. The performance of VBZ is achieved by taking advantage of the properties of the raw signal and therefore is most effective when applied to the signal dataset.
Scregseg (Single-Cell REGulatory landscape SEGmentation) is a tool that facilitates the analysis of single cell ATAC-seq data by an HMM-based segmentation algorithm. Scregseg uses an HMM with Dirichlet-Multinomial emission probabilities to segment the genome either according to distinct relative cross-cell accessibility profiles or (after collapsing the single-cell tracks to pseudo-bulk tracks) to capture distinct cross-cluster accessibility profiles.
Logomaker is a Python package for generating publication-quality sequence logos. Logomaker can generate both standard and highly customized logos illustrating the properties of DNA, RNA, or protein sequences. Logos are rendered as vector graphics embedded within native matplotlib Axes objects, making them easy to style and incorporate into multi-panel figures.
This package offers a set of functions to use in order to compute communities on graphs weighted or unweighted.
PySnpTools is a library for reading and manipulating genetic data. It can, for example, efficiently read whole PLINK *.bed/bim/fam files or parts of those files. It can also efficiently manipulate ranges of integers using set operators such as union, intersection, and difference.
The Spliced Transcripts Alignment to a Reference (STAR) software is based on a previously undescribed RNA-seq alignment algorithm that uses sequential maximum mappable seed search in uncompressed suffix arrays followed by seed clustering and stitching procedure. In addition to unbiased de novo detection of canonical junctions, STAR can discover non-canonical splices and chimeric (fusion) transcripts, and is also capable of mapping full-length RNA sequences.
LibSBML is a library to help you read, write, manipulate, translate, and validate SBML files and data streams. The Systems Biology Markup Language (SBML) is an interchange format for computer models of biological processes. SBML is useful for models of metabolism, cell signaling, and more. It continues to be evolved and expanded by an international community.
SnapTools can operate on snap files the following types of operations:
index the reference genome before alignment;
align reads to the corresponding reference genome;
pre-process by convert pair-end reads into fragments, checking the mapping quality score, alignment and filtration;
create the cell-by-bin matrix.
This package provides utility functions for manipulating BAM files.
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 functions to parse and open (search query) links to genomics related and other websites for R. Useful when you want to explore e.g.: the function of a set of differentially expressed genes.
Forester is a collection of Java libraries for phylogenomics and evolutionary biology research. It includes support for reading, writing, and exporting phylogenetic trees.
BĂogo is a bioinformatics library for the Go language.
Bio++ is a set of C++ libraries for Bioinformatics, including sequence analysis, phylogenetics, molecular evolution and population genetics. This library provides sequence-related modules.