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 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.
Python scripts to find enrichment of GO terms. In addition, this package is used for processing the obo-formatted file from Gene Ontology website. The data structure is a directed acyclic graph that allows easy traversal from leaf to root.
HTSlib is a C library for reading/writing high-throughput sequencing data. It also provides the bgzip, htsfile, and tabix utilities.
SAIGE is a package for efficiently controlling for case-control imbalance and sample relatedness in single-variant assoc tests (SAIGE) and controlling for sample relatedness in region-based assoc tests in large cohorts and biobanks (SAIGE-GENE+).
Bismark is a program to map bisulfite treated sequencing reads to a genome of interest and perform methylation calls in a single step. The output can be easily imported into a genome viewer, such as SeqMonk, and enables a researcher to analyse the methylation levels of their samples straight away. Its main features are:
Bisulfite mapping and methylation calling in one single step
Supports single-end and paired-end read alignments
Supports ungapped and gapped alignments
Alignment seed length, number of mismatches etc are adjustable
Output discriminates between cytosine methylation in CpG, CHG and CHH context
eXpress is a streaming tool for quantifying the abundances of a set of target sequences from sampled subsequences. Example applications include transcript-level RNA-Seq quantification, allele-specific/haplotype expression analysis (from RNA-Seq), transcription factor binding quantification in ChIP-Seq, and analysis of metagenomic data.
SeqGL is a group lasso based algorithm to extract transcription factor sequence signals from ChIP, DNase and ATAC-seq profiles. This package presents a method which uses group lasso to discriminate between bound and non bound genomic regions to accurately identify transcription factors bound at the specific regions.
Anglemania extracts genes from multi-batch scRNA-seq experiments for downstream dataset integration. It improves conventional usage of highly-variable genes for integration tasks.
Sambamba is a high performance modern robust and fast tool (and library), written in the D programming language, for working with SAM and BAM files. Current parallelised functionality is an important subset of samtools functionality, including view, index, sort, markdup, and depth.
Fastp is a tool designed to provide fast all-in-one preprocessing for FastQ files. This tool has multi-threading support to afford high performance.
This tool provides a Python framework to streamline genomics operations. It offers a direct interface to Ensembl genome assemblies and annotations, while also accommodating custom genomes via FASTA/GTF inputs. The primary objective of pybio is to simplify genome management. It achieves this by providing automatic download of Ensembl genome assemblies and annotation, provides Python genomic feature search and sequence retrieval from the managed genomes, STAR indexing and mapping and more.
This package provides an assortment of R functions that is suitable for all types of microbial diversity analyses.
MUSIC is an algorithm for identification of enriched regions at multiple scales in the read depth signals from ChIP-Seq experiments.
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 package contains some tools for processing BAM files including:
bamsormadup: parallel sorting and duplicate marking
bamcollate2: reads BAM and writes BAM reordered such that alignment or collated by query name
bammarkduplicates: reads BAM and writes BAM with duplicate alignments marked using the BAM flags field
bammaskflags: reads BAM and writes BAM while masking (removing) bits from the flags column
bamrecompress: reads BAM and writes BAM with a defined compression setting. This tool is capable of multi-threading.
bamsort: reads BAM and writes BAM resorted by coordinates or query name
bamtofastq: reads BAM and writes FastQ; output can be collated or uncollated by query name.
Cutadapt finds and removes adapter sequences, primers, poly-A tails and other types of unwanted sequence from high-throughput sequencing reads.
An ORF caller finds stretches of DNA that, when translated, are not interrupted by stop codons. OrfM finds and prints these ORFs.
This package implements methods to project single-cell RNA-seq data onto a reference atlas, enabling interpretation of unknown cell transcriptomic states in the the context of known, reference states.
This package provides version 1.12 of the HTSlib C library for high-throughput sequence analysis. The package is primarily useful to developers of other R packages who wish to make use of HTSlib.
Splicekit is a modular platform for splicing analysis from short-read RNA-seq datasets. The platform also integrates pybio for genomic operations and scanRBP for RNA-protein binding studies. The whole analysis is self-contained (one single directory) and the platform is written in Python, in a modular way.
NGS is a domain-specific API for accessing reads, alignments and pileups produced from Next Generation Sequencing. The API itself is independent from any particular back-end implementation, and supports use of multiple back-ends simultaneously.
This package is a Python-based command line interface for processing .bam files with mitochondrial reads and generating high-quality heteroplasmy estimation from sequencing data. The mgatk package places a special emphasis on mitochondrial genotypes generated from single-cell genomics data, primarily mtscATAC-seq, but is generally applicable across other assays.
This R tool infers, visualizes, and analyzes cell-cell communication networks. It supports scRNA-seq and spatially resolved transcriptomics data.
FAN-C provides a pipeline for analysing Hi-C data starting at mapped paired-end sequencing reads.