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.
Bio-vcf provides a DSL for processing the VCF format. Record named fields can be queried with regular expressions. Bio-vcf is a new generation VCF parser, filter and converter. Bio-vcf is not only very fast for genome-wide (WGS) data, it also comes with a filtering, evaluation and rewrite language and can output any type of textual data, including VCF header and contents in RDF and JSON.
StringTie is a fast and efficient assembler of RNA-Seq sequence alignments into potential transcripts. It uses a novel network flow algorithm as well as an optional de novo assembly step to assemble and quantitate full-length transcripts representing multiple splice variants for each gene locus. Its input can include not only the alignments of raw reads used by other transcript assemblers, but also alignments of longer sequences that have been assembled from those reads. To identify differentially expressed genes between experiments, StringTie's output can be processed either by the Cuffdiff or Ballgown programs.
Genrich is a peak-caller for genomic enrichment assays (e.g. ChIP-seq, ATAC-seq). It analyzes alignment files generated following the assay and produces a file detailing peaks of significant enrichment.
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.
The porechop package is a tool for finding and removing adapters from Oxford Nanopore reads. Adapters on the ends of reads are trimmed off, and when a read has an adapter in its middle, it is treated as chimeric and chopped into separate reads. Porechop performs thorough alignments to effectively find adapters, even at low sequence identity. Porechop also supports demultiplexing of Nanopore reads that were barcoded with the Native Barcoding Kit, PCR Barcoding Kit or Rapid Barcoding Kit.
MACS is an implementation of a ChIP-Seq analysis algorithm for identifying transcript factor binding sites named Model-based Analysis of ChIP-Seq (MACS). MACS captures the influence of genome complexity to evaluate the significance of enriched ChIP regions and it improves the spatial resolution of binding sites through combining the information of both sequencing tag position and orientation.
This package provides a VCF parser for Python.
Very fast parallel big-data BLAST XML file parser which can be used as command line utility. Use blastxmlparser to: Parse BLAST XML; filter output; generate FASTA, JSON, YAML, RDF, JSON-LD, HTML, CSV, tabular output etc.
CMSeq is a set of commands to provide an interface to .bam files for coverage and sequence consensus.
This package analyses the Oxford Nanopore sequencing data at signal-level. Nanopolish can calculate an improved consensus sequence for a draft genome assembly, detect base modifications, call SNPs (Single nucleotide polymorphisms) and indels with respect to a reference genome and more.
This package is used for cell type identification in spatial transcriptomics. It also handles cell type-specific differential expression.
ScVelo is a scalable toolkit for RNA velocity analysis in single cells. RNA velocity enables the recovery of directed dynamic information by leveraging splicing kinetics. scVelo generalizes the concept of RNA velocity by relaxing previously made assumptions with a stochastic and a dynamical model that solves the full transcriptional dynamics. It thereby adapts RNA velocity to widely varying specifications such as non-stationary populations.
This package addresses the challenge of handling large amounts of data that are now routinely generated from DNA sequencing centers. deepTools contains useful modules to process the mapped reads data for multiple quality checks, creating normalized coverage files in standard bedGraph and bigWig file formats, that allow comparison between different files. Finally, using such normalized and standardized files, deepTools can create many publication-ready visualizations to identify enrichments and for functional annotations of the genome.
This package provides an accurate VCF/GFF3/GTF LiftOver tool for new genome assemblies.
ikarus is a stepwise machine learning pipeline that tries to cope with a task of distinguishing tumor cells from normal cells. Leveraging multiple annotated single cell datasets it can be used to define a gene set specific to tumor cells. First, the latter gene set is used to rank cells and then to train a logistic classifier for the robust classification of tumor and normal cells. Finally, sensitivity is increased by propagating the cell labels based on a custom cell-cell network. ikarus is tested on multiple single cell datasets to ascertain that it achieves high sensitivity and specificity in multiple experimental contexts.
This package lets you read and write the PLINK BED format, simply and efficiently.
deMULTIplex is an R package for analyzing single-cell RNA sequencing data generated with the MULTI-seq sample multiplexing method. The package includes software to
Convert raw MULTI-seq sample barcode library FASTQs into a sample barcode UMI count matrix, and
Classify cell barcodes into sample barcode groups.
Pypairix is a Python module for fast querying on a pairix-indexed bgzipped text file that contains a pair of genomic coordinates per line.
CD-HIT is a program for clustering and comparing protein or nucleotide sequences. CD-HIT is designed to be fast and handle extremely large databases.
This package provides a new batch effect correction method based on Projection to Latent Structures Discriminant Analysis named “PLSDA-batch” to correct data prior to any downstream analysis. PLSDA-batch estimates latent components related to treatment and batch effects to remove batch variation. The method is multivariate, non-parametric and performs dimension reduction. Combined with centered log ratio transformation for addressing uneven library sizes and compositional structure, PLSDA-batch addresses all characteristics of microbiome data that existing correction methods have ignored so far.
This package provides a computational toolkit in R for the integration, exploration, and analysis of high-dimensional single-cell cytometry and imaging data.
This package adds 3D perspective plotting of points, paths, and line, 3D perspective axes, 3D perspective annotations, and wireframe plots.
This package provides helper functions to detect cross-hybridization on Illumina DNAm arrays.
The loom file format is an efficient format for very large omics datasets, consisting of a main matrix, optional additional layers, a variable number of row and column annotations. Loom also supports sparse graphs. This library makes it easy to work with .loom files for single-cell RNA-seq data.