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.
This package builds on Seurat's Doheatmap function code to produce a heatmap from a Seurat object with multiple annotation bars.
This package provides an accurate VCF/GFF3/GTF LiftOver tool for new genome assemblies.
This package offers a flexible statistical simulator for scRNA-seq data. It can generate data that captures gene correlation. Additionally, it allows for varying the number of cells and sequencing depth.
Samtools implements various utilities for post-processing nucleotide sequence alignments in the SAM, BAM, and CRAM formats, including indexing, variant calling (in conjunction with bcftools), and a simple alignment viewer.
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.
Mosaicatcher counts Strand-seq reads and classifies strand states of each chromosome in each cell using a Hidden Markov Model.
MyGene.Info provides simple-to-use REST web services to query/retrieve gene annotation data. It's designed with simplicity and performance emphasized. Mygene is a Python wrapper to access MyGene.Info services.
Harmony is an algorithm for integrating multiple high-dimensional datasets with fuzzy k-means and locally linear adjustments.
This package offers Cython bindings and a Python interface for Prodigal. Prodigal is an ORF finder designed for both genomes and metagenomes.
muon is a multimodal omics Python framework.
python-scanrbp is a Python package that provides the scanRBP tool that loads RNA-protein binding motif PWM and computes the log-odds scores for all the loaded RBPs across a given genomic sequence and draws a heatmap of the scores.
This package converts the output of the Sailfish and Salmon RNA-seq quantification tools so that it can be used with the Sleuth differential analysis package.
This is a collection of utility functions for Seurat. These functions allow the automation and multiplexing of plotting, 3D plotting, visualization of statistics & QC, interaction with the Seurat object. Some functionalities require functions from CodeAndRoll and MarkdownReports libraries.
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.
This package provides an object for plotting GRanges, RleList, UCSC file formats, and ffTrack objects in multi-track panels.
Forester is a collection of Java libraries for phylogenomics and evolutionary biology research. It includes support for reading, writing, and exporting phylogenetic trees.
This package is a library to enable flexible and scalable operations on genomic interval dataframes in Python. Bioframe enables access to a rich set of dataframe operations. Working in Python enables rapid visualization and iteration of genomic analyses. The philosophy underlying bioframe is to enable flexible operations. Instead of creating a function for every possible use-case, we encourage users to compose functions to achieve their goals.
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.).
inStrain is a Python program for analysis of co-occurring genome populations from metagenomes that allows highly accurate genome comparisons, analysis of coverage, microdiversity, and linkage, and sensitive SNP detection with gene localization and synonymous non-synonymous identification.
Aragorn identifies transfer RNA, mitochondrial RNA and transfer-messenger RNA from nucleotide sequences, based on homology to known tRNA consensus sequences and RNA structure. It also outputs the secondary structure of the predicted RNA.
This library contains the genomics components of the Bio++ sequence library. It is part of the Bio++ project.
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.
MuSiC is a deconvolution method that utilizes cross-subject scRNA-seq to estimate cell type proportions in bulk RNA-seq data.
InDelFixer is a sensitive aligner for 454, Illumina and PacBio data, employing a full Smith-Waterman alignment against a reference. This Java command line application aligns Next-Generation Sequencing (NGS) and third-generation reads to a set of reference sequences, by a prior fast k-mer matching and removes indels, causing frame shifts. In addition, only a specific region can be considered. An iterative refinement of the alignment can be performed, by alignment against the consensus sequence with wobbles. The output is in SAM format.