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.
Fluff is a Python package that contains several scripts to produce pretty, publication-quality figures for next-generation sequencing experiments.
This is a Python package for the interactive visualization of bulk RNA-seq data. It provides a range of plotting functions and interactive tools to explore and analyze bulk RNA-seq data.
This package provides Python bindings to the bwa mem aligner.
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.
SortMeRNA is a biological sequence analysis tool for filtering, mapping and OTU picking of NGS reads. The core algorithm is based on approximate seeds and allows for fast and sensitive analyses of nucleotide sequences. The main application of SortMeRNA is filtering rRNA from metatranscriptomic data.
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.
CellTypist is an automated cell type annotation tool for scRNA-seq datasets on the basis of logistic regression classifiers optimised by the stochastic gradient descent algorithm. CellTypist allows for cell prediction using either built-in (with a current focus on immune sub-populations) or custom models, in order to assist in the accurate classification of different cell types and subtypes.
BamTools provides both a C++ API and a command-line toolkit for handling BAM files.
This is a fast parser for minimap2 PAF (Pairwise mApping Format) files.
ctxcore is part of the SCENIC suite of tools. It provides core functions for pycisTarget and SCENIC.
Several studies focus on the inference of developmental and response trajectories from single cell RNA-Seq (scRNA-Seq) data. A number of computational methods, often referred to as pseudo-time ordering, have been developed for this task. CRISPR has also been used to reconstruct lineage trees by inserting random mutations. The tbsp package implements an alternative method to detect significant, cell type specific sequence mutations from scRNA-Seq data.
PiGX RNAseq is an analysis pipeline for preprocessing and reporting for RNA sequencing experiments. It is easy to use and produces high quality reports. The inputs are reads files from the sequencing experiment, and a configuration file which describes the experiment. In addition to quality control of the experiment, the pipeline produces a differential expression report comparing samples in an easily configurable manner.
This package provides a companion annotation file to the IlluminaHumanMethylationEPICmanifest package based on the same annotation 1.0B5.
This package provides necessary tools for the analysis of the genomic interaction data stored in .cool format. This collection of tools includes operations like compartment, insulation or peak calling.
This is a collection of functions created and/or curated to aid in the visualization and analysis of single-cell data using R.
Bowtie 2 is a fast and memory-efficient tool for aligning sequencing reads to long reference sequences. It is particularly good at aligning reads of about 50 up to 100s or 1,000s of characters, and particularly good at aligning to relatively long (e.g. mammalian) genomes. Bowtie 2 indexes the genome with an FM Index to keep its memory footprint small: for the human genome, its memory footprint is typically around 3.2 GB. Bowtie 2 supports gapped, local, and paired-end alignment modes.
The IDR (Irreproducible Discovery Rate) framework is a unified approach to measure the reproducibility of findings identified from replicate experiments and provide highly stable thresholds based on reproducibility.
PDBFixer is designed to rectify issues in Protein Data Bank files. Its intuitive interface simplifies the process of resolving problems encountered in PDB files prior to simulation tasks.
Sailfish is a tool for genomic transcript quantification from RNA-seq data. It requires a set of target transcripts (either from a reference or de-novo assembly) to quantify. All you need to run sailfish is a fasta file containing your reference transcripts and a (set of) fasta/fastq file(s) containing your reads.
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.
This package implements methods for batch correction and integration of scRNA-seq datasets, based on the Seurat anchor-based integration framework. In particular, STACAS is optimized for the integration of heterogeneous datasets with only limited overlap between cell sub-types (e.g. TIL sets of CD8 from tumor with CD8/CD4 T cells from lymphnode), for which the default Seurat alignment methods would tend to over-correct biological differences. The 2.0 version of the package allows the users to incorporate explicit information about cell-types in order to assist the integration process.
DelayedArray based image operations.
Roary is a high speed stand alone pan genome pipeline, which takes annotated assemblies in GFF3 format (produced by the Prokka program) and calculates the pan genome. Using a standard desktop PC, it can analyse datasets with thousands of samples, without compromising the quality of the results. 128 samples can be analysed in under 1 hour using 1 GB of RAM and a single processor. Roary is not intended for metagenomics or for comparing extremely diverse sets of genomes.
BayesPrism includes deconvolution and embedding learning modules. The deconvolution module models a prior from cell type-specific expression profiles from scRNA-seq to jointly estimate the posterior distribution of cell type composition and cell type-specific gene expression from bulk RNA-seq expression of tumor samples. The embedding learning module uses Expectation-maximization (EM) to approximate the tumor expression using a linear combination of malignant gene programs while conditional on the inferred expression and fraction of non-malignant cells estimated by the deconvolution module.