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.
FLASH (Fast Length Adjustment of SHort reads) is a tool to merge paired-end reads from next-generation sequencing experiments. FLASH is designed to merge pairs of reads when the original DNA fragments are shorter than twice the length of reads. The resulting longer reads can significantly improve genome assemblies. They can also improve transcriptome assembly when FLASH is used to merge RNA-seq data.
Drop-seq is a technology to enable biologists to analyze RNA expression genome-wide in thousands of individual cells at once. This package provides tools to perform Drop-seq analyses.
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).
Bio++ is a set of C++ libraries for Bioinformatics, including sequence analysis, phylogenetics, molecular evolution and population genetics. It is Object Oriented and is designed to be both easy to use and computer efficient. Bio++ intends to help programmers to write computer expensive programs, by providing them a set of re-usable tools.
Bioinformaticians often have to convert sequence files between formats and do little manipulations on them, and it's not worth writing scripts for that. Seqmagick is a utility to expose the file format conversion in BioPython in a convenient way. Instead of having a big mess of scripts, there is one that takes arguments.
This package is a set of R functions for generating precise figures. This tool helps you to create clean markdown reports about what you just discovered with your analysis script.
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.
This package contains data used by pagoda2. The data within this package are the 3000 bone marrow cells used for vignettes.
Biosoup is a C++ collection of header-only data structures used for storage and logging in bioinformatics tools.
LAMMPS is a classical molecular dynamics simulator designed to run efficiently on parallel computers. LAMMPS has potentials for solid-state materials (metals, semiconductors), soft matter (biomolecules, polymers), and coarse-grained or mesoscopic systems. It can be used to model atoms or, more generically, as a parallel particle simulator at the atomic, meso, or continuum scale.
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.
twobitreader is a Python library for reading .2bit files as used by the UCSC genome browser.
This package is tools for analysing intercellular and intracellular signaling from single cell RNA-seq (scRNA-seq) data.
Pysam is a Python module for reading and manipulating files in the SAM/BAM format. Pysam is a lightweight wrapper of the SAMtools C API. It also includes an interface for tabix.
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.
This package is a collection of Perl, Python, and R scripts for manipulating 3C/4C/5C/Hi-C data.
This package provides a package that makes it easy to implement sankey, alluvial and sankey bump plots in ggplot2.
Grassroots DICOM (GDCM) is an implementation of the DICOM standard designed to be open source so that researchers may access clinical data directly. GDCM includes a file format definition and a network communications protocol, both of which should be extended to provide a full set of tools for a researcher or small medical imaging vendor to interface with an existing medical database.
CPAT is a method to distinguish coding and noncoding RNA by using a logistic regression model based on four pure sequence-based, linguistic features: ORF size, ORF coverage, Ficket TESTCODE, and Hexamer usage bias. Linguistic features based method does not require other genomes or protein databases to perform alignment and is more robust. Because it is alignment-free, it runs much faster and also easier to use.
gkm-SVM, a sequence-based method for predicting regulatory DNA elements, is a useful tool for studying gene regulatory mechanisms. LS-GKM is an effort to improve the method. It offers much better scalability and provides further advanced gapped k-mer based kernel functions. As a result, LS-GKM achieves considerably higher accuracy than the original gkm-SVM.
This is a package for fast Non-negative Matrix Factorization (NMF) with automatic rank-determination for dimension reduction of single-cell data using Seurat, RcppML nmf, SingleCellExperiments and similar.
HMMER is used for searching sequence databases for homologs of protein sequences, and for making protein sequence alignments. It implements methods using probabilistic models called profile hidden Markov models (profile HMMs).
This package aims to produce high-quality genome browser tracks that are highly customizable. Currently, it is possible to plot: bigwig, bed (many options), bedgraph, links (represented as arcs), and Hi-C matrices. pyGenomeTracks can make plots with or without Hi-C data.
Skewer implements the bit-masked k-difference matching algorithm dedicated to the task of adapter trimming and it is specially designed for processing next-generation sequencing (NGS) paired-end sequences.