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.
LoFreq is a fast and sensitive variant-caller for inferring SNVs and indels from next-generation sequencing data. It makes full use of base-call qualities and other sources of errors inherent in sequencing (e.g. mapping or base/indel alignment uncertainty), which are usually ignored by other methods or only used for filtering.
CMSeq is a set of commands to provide an interface to .bam files for coverage and sequence consensus.
TADbit is a complete Python library to deal with all steps to analyze, model, and explore 3C-based data. With TADbit the user can map FASTQ files to obtain raw interaction binned matrices (Hi-C like matrices), normalize and correct interaction matrices, identify and compare the so-called Topologically Associating Domains (TADs), build 3D models from the interaction matrices, and finally, extract structural properties from the models. TADbit is complemented by TADkit for visualizing 3D models.
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.
Psupertime is supervised pseudotime for single cell RNAseq data. It uses single cell RNAseq data, where the cells have a known ordering. This ordering helps to identify a small number of genes which place cells in that known order. It can be used for discovery of relevant genes, for identification of subpopulations, and characterization of further unknown or differently labelled data.
Cyvcf2 is a Cython wrapper around htslib built for fast parsing of Variant Call Format (VCF) files.
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.
The ccwl is a concise syntax to express CWL workflows. ccwl is a compiler to generate CWL workflows from concise descriptions in ccwl. It is implemented as an EDSL in the Scheme programming language.
This is an R package providing additional capabilities and speed for GenomicRanges operations.
MOSAIK is a program for mapping second and third-generation sequencing reads to a reference genome. MOSAIK can align reads generated by all the major sequencing technologies, including Illumina, Applied Biosystems SOLiD, Roche 454, Ion Torrent and Pacific BioSciences SMRT.
ShoRAH is a project for the analysis of next generation sequencing data. It is designed to analyse genetically heterogeneous samples. Its tools provide error correction, haplotype reconstruction and estimation of the frequency of the different genetic variants present in a mixed sample.
This package provides the kentUtils, a selection of bioinformatics utilities used in combination with the UCSC genome browser.
This package provides a new batch effect correction method based on Projection to Latent Structures Discriminant Analysis named “PLSDA-batch” to correct data prior to any downstream analysis. PLSDA-batch estimates latent components related to treatment and batch effects to remove batch variation. The method is multivariate, non-parametric and performs dimension reduction. Combined with centered log ratio transformation for addressing uneven library sizes and compositional structure, PLSDA-batch addresses all characteristics of microbiome data that existing correction methods have ignored so far.
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.
This package is a client implementation of the GA4GH htsget protocol. It provides a simple and reliable way to retrieve genomic data from servers supporting the protocol.
This package Copynumber KAryotyping of Tumors infers genomic copy number and subclonal structure of human tumors using integrative Bayesian approaches to identify genome-wide aneuploidy at 5MB resolution in single cells data. It separates tumor cells and tumor subclones from normal cells using high-throughput sc-RNAseq data.
python-cwl-utils provides python utilities and autogenerated classes for loading and parsing CWL v1.0, CWL v1.1, and CWL v1.2 documents.
BioRuby comes with a comprehensive set of Ruby development tools and libraries for bioinformatics and molecular biology. BioRuby has components for sequence analysis, pathway analysis, protein modelling and phylogenetic analysis; it supports many widely used data formats and provides easy access to databases, external programs and public web services, including BLAST, KEGG, GenBank, MEDLINE and GO.
This package provides a method to sample cells from single-cell data. It also generates an aggregate profile on a pruned K-Nearest Neighbor graph. This approach leads to an improved gene expression profile for quantifying gene regulations.
This package is designed to streamline scATAC analyses in R.
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.
This package provides a toolkit for measuring and comparing ATAC-seq results. It was written to make it easier to spot differences that might be caused by ATAC-seq library prep or sequencing. The main program, ataqv, examines aligned reads and reports some basic metrics.
This package implements parallel block gzip. For many formats, in particular genomics data formats, data are compressed in fixed-length blocks such that they can be easily indexed based on a (genomic) coordinate order, since typically each block is sorted according to this order. This allows for each block to be individually compressed (deflated), or more importantly, decompressed (inflated), with the latter enabling random retrieval of data in large files (gigabytes to terabytes). pbgzip is not limited to any particular format, but certain features are tailored to genomics data formats when enabled. Parallel decompression is somewhat faster, but the true speedup comes during compression.
Presto is a python toolkit for processing raw reads from high-throughput sequencing of B cell and T cell repertoires.