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.
Screed parses FASTA and FASTQ files and generates databases. Values such as sequence name, sequence description, sequence quality and the sequence itself can be retrieved from these databases.
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.
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.
PRANK is a probabilistic multiple sequence alignment program for DNA, codon and amino-acid sequences. It is based on a novel algorithm that treats insertions correctly and avoids over-estimation of the number of deletion events. In addition, PRANK borrows ideas from maximum likelihood methods used in phylogenetics and correctly takes into account the evolutionary distances between sequences. Lastly, PRANK allows for defining a potential structure for sequences to be aligned and then, simultaneously with the alignment, predicts the locations of structural units in the sequences.
This package implements the method csSAM that computes cell-specific differential expression from measured cell proportions using SAM.
This is a package for normalizing Hi-C contact counts efficiently.
This is a Python module for analyzing cell-hashing/nucleus-hashing data. It is the demultiplexing module of Pegasus, which is used by Cumulus in the demultiplexing step.
Parabam is a tool for processing sequencing files in parallel. It uses Python's native multiprocessing framework to apply a user defined rule on an input file.
CellBender is a software package for eliminating technical artifacts from high-throughput single-cell RNA sequencing (scRNA-seq) data.
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.
Fluff is a Python package that contains several scripts to produce pretty, publication-quality figures for next-generation sequencing experiments.
The WiggleTools package allows genomewide data files to be manipulated as numerical functions, equipped with all the standard functional analysis operators (sum, product, product by a scalar, comparators), and derived statistics (mean, median, variance, stddev, t-test, Wilcoxon's rank sum test, etc).
Entrez Direct (EDirect) is a method for accessing the National Center for Biotechnology Information's (NCBI) set of interconnected databases (publication, sequence, structure, gene, variation, expression, etc.) from a terminal. Functions take search terms from command-line arguments. Individual operations are combined to build multi-step queries. Record retrieval and formatting normally complete the process.
EDirect also provides an argument-driven function that simplifies the extraction of data from document summaries or other results that are returned in structured XML format. This can eliminate the need for writing custom software to answer ad hoc questions.
This package implements FLAIR (Full-Length Alternative Isoform analysis of RNA) for the correction, isoform definition, and alternative splicing analysis of noisy reads. FLAIR has primarily been used for nanopore cDNA, native RNA, and PacBio sequencing reads.
The preseq package is aimed at predicting and estimating the complexity of a genomic sequencing library, equivalent to predicting and estimating the number of redundant reads from a given sequencing depth and how many will be expected from additional sequencing using an initial sequencing experiment. The estimates can then be used to examine the utility of further sequencing, optimize the sequencing depth, or to screen multiple libraries to avoid low complexity samples.
This package provides version 1.12 of the HTSlib C library for high-throughput sequence analysis. The package is primarily useful to developers of other R packages who wish to make use of HTSlib.
HISAT is a fast and sensitive spliced alignment program for mapping RNA-seq reads. In addition to one global FM index that represents a whole genome, HISAT uses a large set of small FM indexes that collectively cover the whole genome. These small indexes (called local indexes) combined with several alignment strategies enable effective alignment of RNA-seq reads, in particular, reads spanning multiple exons.
Taxtastic is software written in python used to build and maintain reference packages i.e. collections of reference trees, reference alignments, profiles, and associated taxonomic information.
This tool provides a Python framework to streamline genomics operations. It offers a direct interface to Ensembl genome assemblies and annotations, while also accommodating custom genomes via FASTA/GTF inputs. The primary objective of pybio is to simplify genome management. It achieves this by providing automatic download of Ensembl genome assemblies and annotation, provides Python genomic feature search and sequence retrieval from the managed genomes, STAR indexing and mapping and more.
Cutadapt finds and removes adapter sequences, primers, poly-A tails and other types of unwanted sequence from high-throughput sequencing reads.
This package provides a robust, parallelized Python CLI for annotating three prime UTR.
This package provides an automated pipeline for spatial mapping of unique transcripts.
Millefy is a tool for visualizing read coverage of scRNA-seq(single-cell RNA sequencing) datasets in genomic contexts. By dynamically and automatically reorder single cells based on locus-specific pseudo time, Millefy highlights cell-to-cell heterogeneity in read coverage of scRNA-seq data.
This package is used for cell type identification in spatial transcriptomics. It also handles cell type-specific differential expression.