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.
CheckM provides a set of tools for assessing the quality of genomes recovered from isolates, single cells, or metagenomes. It provides robust estimates of genome completeness and contamination by using collocated sets of genes that are ubiquitous and single-copy within a phylogenetic lineage. Assessment of genome quality can also be examined using plots depicting key genomic characteristics (e.g., GC, coding density) which highlight sequences outside the expected distributions of a typical genome. CheckM also provides tools for identifying genome bins that are likely candidates for merging based on marker set compatibility, similarity in genomic characteristics, and proximity within a reference genome.
The pbcopper library provides a suite of data structures, algorithms, and utilities for PacBio C++ applications.
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.
PAML (for Phylogentic Analysis by Maximum Likelihood) contains a few programs for model fitting and phylogenetic tree reconstruction using nucleotide or amino-acid sequence data.
This package aims to bring the power and flexibility of AnnData to the R ecosystem, allowing you to effortlessly manipulate and analyze your single-cell data. This package lets you work with backed h5ad and zarr files, directly access various slots (e.g. X, obs, var), or convert the data into SingleCellExperiment and Seurat objects.
MafFilter is a program dedicated to the analysis of genome alignments. It parses and manipulates MAF files as well as more simple fasta files. This package can be used to design a pipeline as a series of consecutive filters, each performing a dedicated analysis. Many of the filters are available, from alignment cleaning to phylogeny reconstruction and population genetics analysis. Despite various filtering options and format conversion tools, MafFilter can compute a wide range of statistics (phylogenetic trees, nucleotide diversity, inference of selection, etc.).
This library implements a FASTA and a FASTQ parser without relying on a complex dependency tree.
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.
This package provides a Python module creating/accessing GTF-based interval trees with associated meta-data. It is primarily used by the deeptools package.
PLINK is a whole genome association analysis toolset, designed to perform a range of basic, large-scale analyses in a computationally efficient manner. The focus of PLINK is purely on analysis of genotype/phenotype data, so there is no support for steps prior to this (e.g. study design and planning, generating genotype or CNV calls from raw data). Through integration with gPLINK and Haploview, there is some support for the subsequent visualization, annotation and storage of results.
Arriba is a command-line tool for the detection of gene fusions from RNA-Seq data. It was developed for the use in a clinical research setting. Therefore, short runtimes and high sensitivity were important design criteria. It is based on the fast STAR aligner and the post-alignment runtime is typically just around two minutes. In contrast to many other fusion detection tools which build on STAR, Arriba does not require to reduce the alignIntronMax parameter of STAR to detect small deletions.
This package provides a Python package for reading raw fcs files
This package is intended to help users to efficiently analyze genomic data resulting from various experiments.
This package performs a fast Wilcoxon rank sum test and auROC analysis.
Circe is a Python package for inferring co-accessibility networks from single-cell ATAC-seq data, using skggm for the graphical lasso and python-scanpy for data processing.
Scanorama enables batch-correction and integration of heterogeneous scRNA-seq datasets, which is described in the paper "Efficient integration of heterogeneous single-cell transcriptomes using Scanorama" by Brian Hie, Bryan Bryson, and Bonnie Berger.
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.
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 package provides a library and collection of scripts to work with Illumina paired-end data (for CASAVA 1.8+).
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 R package lets you estimate signatures of mutational processes and their activities on mutation count data. Starting from a set of single-nucleotide variants (SNVs), it allows both estimation of the exposure of samples to predefined mutational signatures (including whether the signatures are present at all), and identification of signatures de novo from the mutation counts.
This is an R package that integrates the installation of doublet-detection methods. In addition, this tool is used for execution and benchmark of those eight mentioned methods.
This package implements two functions:
pairwise.adonisis a wrapper function for multilevel pairwise comparison using adonis2 from package vegan. The function returns adjusted p-values usingp.adjust(). It does not accept interaction between factors neither strata.pairwise.adonis2accepts a model formula like in adonis from vegan. You can use interactions between factors and define strata to constrain permutations. For pairwise comparison a list of unique pairwise combination of factors is produced.
PRINSEQ is a bioinformatics tool to help you preprocess your genomic or metagenomic sequence data in FASTA or FASTQ formats. The tool is written in Perl and can be helpful if you want to filter, reformat, or trim your sequence data. It also generates basic statistics for your sequences.