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.
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.
Newick-utils is a suite of utilities for processing phylogenetic trees in Newick format. Functions include re-rooting, extracting subtrees, trimming, pruning, condensing, drawing (ASCII graphics or SVG).
This package provides a fast and accurate analysis toolkit for single cell ATAC-seq (Assay for transposase-accessible chromatin using sequencing). Single cell ATAC-seq can resolve the heterogeneity of a complex tissue and reveal cell-type specific regulatory landscapes. However, the exceeding data sparsity has posed unique challenges for the data analysis. This package r-snapatac is an end-to-end bioinformatics pipeline for analyzing large- scale single cell ATAC-seq data which includes quality control, normalization, clustering analysis, differential analysis, motif inference and exploration of single cell ATAC-seq sequencing data.
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.
This package provides a collection of methods to extract gene programs from single-cell gene expression data using non-negative matrix factorization (NMF). GeneNMF contains functions to directly interact with the Seurat toolkit and derive interpretable gene program signatures.
This package provides a tool for identifying and removing doublets in single-cell RNA-seq data.
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.
PSIplot is an R package for generating plots of percent spliced-in (PSI) values of alternatively-spliced exons that were computed by vast-tools, an RNA-Seq pipeline for alternative splicing analysis. The plots are generated using ggplot2.
Proteinortho is a tool to detect orthologous genes across different species. For doing so, it compares similarities of given gene sequences and clusters them to find significant groups. The algorithm was designed to handle large-scale data and can be applied to hundreds of species at once.
Exonerate is a generic tool for pairwise sequence comparison. It allows the alignment of sequences using a many alignment models, either exhaustive dynamic programming or a variety of heuristics.
This tool offers a pipeline for inferring gene expression programs from scRNA-Seq. It takes a count matrix (N cells X G genes) as input and produces a (K x G) matrix of gene expression programs (GEPs) and a (N x K) matrix specifying the usage of each program for each cell in the data.
The Filtlong package is a tool for filtering long reads by quality. It can take a set of long reads and produce a smaller, better subset. It uses both read length (longer is better) and read identity (higher is better) when choosing which reads pass the filter.
This package provides an accurate VCF/GFF3/GTF LiftOver tool for new genome assemblies.
The loom file format is an efficient format for very large omics datasets, consisting of a main matrix, optional additional layers, a variable number of row and column annotations. Loom also supports sparse graphs. This library makes it easy to work with .loom files for single-cell RNA-seq data.
This library implements a FASTA and a FASTQ parser without relying on a complex dependency tree.
CGAT-core is a set of libraries and helper functions used to enable researchers to design and build computational workflows for the analysis of large-scale data-analysis.
This package contains data used by pagoda2. The data within this package are the 3000 bone marrow cells used for vignettes.
HTSJDK is an implementation of a unified Java library for accessing common file formats, such as SAM and VCF, used for high-throughput sequencing (HTS) data. There are also an number of useful utilities for manipulating HTS data.
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 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 framework to process and analyze data from high-throughput sequencing (HTS) assays
This package provides tools for dealing with Unique Molecular Identifiers (UMIs) and Random Molecular Tags (RMTs) in genetic sequences. There are six tools: the extract and whitelist commands are used to prepare a fastq containing UMIs +/- cell barcodes for alignment. The remaining commands, group, dedup, and count/count_tab, are used to identify PCR duplicates using the UMIs and perform different levels of analysis depending on the needs of the user.
This framework facilitates the execution of differential junction usage (DJU) methods. Additionally, it enables the integration of results from multiple DJU methods.