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.
Vembrane simultaneously filters variants based on any INFO or FORMAT field, CHROM, POS, ID, REF, ALT, QUAL, FILTER, and the annotation field ANN. When filtering based on ANN, annotation entries are filtered first. If no annotation entry remains, the entire variant is deleted.
PiGx SARS-CoV-2 is a pipeline for analysing data from sequenced wastewater samples and identifying given variants-of-concern of SARS-CoV-2. The pipeline can be used for continuous sampling. The output report will provide an intuitive visual overview about the development of variant abundance over time and location.
The wavefront alignment (WFA) algorithm is an exact gap-affine algorithm that takes advantage of homologous regions between the sequences to accelerate the alignment process.
This package provides a Variant Effect Predictor, which predicts the functional effects of genomic variants. It also provides Haplosaurus, which uses phased genotype data to predict whole-transcript haplotype sequences, and Variant Recoder, which translates between different variant encodings.
QTLtools is a tool set for molecular QTL discovery and analysis. It allows going from the raw genetic sequence data to collection of molecular Quantitative Trait Loci (QTLs) in few easy-to-perform steps.
Forester is a collection of Java libraries for phylogenomics and evolutionary biology research. It includes support for reading, writing, and exporting phylogenetic trees.
PhenoGraph is a clustering method designed for high-dimensional single-cell data. It works by creating a graph representing phenotypic similarities between cells and then identifying communities in this graph.
This package provides R miscellaneous utilities for basic data manipulation, debugging, visualization, lsf management, and common mskilab tasks.
MUSCLE aims to be a fast and accurate multiple sequence alignment program for nucleotide and protein sequences.
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.
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.
This is an R package providing additional capabilities and speed for GenomicRanges operations.
Phylogenetic Analysis with Space/Time models (PHAST) is a collection of command-line programs and supporting libraries for comparative and evolutionary genomics. Best known as the search engine behind the Conservation tracks in the University of California, Santa Cruz (UCSC) Genome Browser, PHAST also includes several tools for phylogenetic modeling, functional element identification, as well as utilities for manipulating alignments, trees and genomic annotations.
This package provides a collection of useful functions for working with DNA methylation micro-array data.
Fastahack is a small application for indexing and extracting sequences and subsequences from FASTA files. The included library provides a FASTA reader and indexer that can be embedded into applications which would benefit from directly reading subsequences from FASTA files. The library automatically handles index file generation and use.
This package provides an RNA-seq workflow for differential transcript usage (DTU) following Salmon quantification. This workflow performs a DTU analysis on simulated data. It also shows how to use stageR to perform two-stage testing of DTU, a statistical framework to screen at the gene level and then confirm which transcripts within the significant genes show evidence of DTU.
MethylDackel will process a coordinate-sorted and indexed BAM or CRAM file containing some form of BS-seq alignments and extract per-base methylation metrics from them. MethylDackel requires an indexed fasta file containing the reference genome as well.
The FASTX-Toolkit is a collection of command line tools for Short-Reads FASTA/FASTQ files preprocessing.
Next-Generation sequencing machines usually produce FASTA or FASTQ files, containing multiple short-reads sequences. The main processing of such FASTA/FASTQ files is mapping the sequences to reference genomes. However, it is sometimes more productive to preprocess the files before mapping the sequences to the genome---manipulating the sequences to produce better mapping results. The FASTX-Toolkit tools perform some of these preprocessing tasks.
The goal of bedtorch is to provide a fast BED file manipulation tool suite native in R.
Seqtk is a fast and lightweight tool for processing sequences in the FASTA or FASTQ format. It parses both FASTA and FASTQ files which can be optionally compressed by gzip.
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.
Anglemania extracts genes from multi-batch scRNA-seq experiments for downstream dataset integration. It improves conventional usage of highly-variable genes for integration tasks.
PyEGA3 is a tool for viewing and downloading files from authorized EGA datasets. It uses the EGA data API and has several key features:
Files are transferred over secure https connections and received unencrypted, so no need for decryption after download.
Downloads resume from where they left off in the event that the connection is interrupted.
Supports file segmenting and parallelized download of segments, improving overall performance.
After download completes, file integrity is verified using checksums.
Implements the GA4GH-compliant htsget protocol for download of genomic ranges for data files with accompanying index files.