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 provides Python bindings to the UCSC Big Binary (bigWig/bigBed) file library. This provides read-level access to local and remote bigWig and bigBed files but no write capabilitites. The main feature is fast retrieval of range queries into numpy arrays.
PiGx SARS-CoV-2 is a pipeline for analysing data from sequenced wastewater samples and identifying given variants-of-concern of SARS-CoV-2. The pipeline can be used for continuous sampling. The output report will provide an intuitive visual overview about the development of variant abundance over time and location.
Circus is an R package for annotation, analysis and visualization of circRNA data. Users can annotate their circRNA candidates with host genes, gene features they are spliced from, and discriminate between known and yet unknown splice junctions. Circular-to-linear ratios of circRNAs can be calculated, and a number of descriptive plots easily generated.
BSeq-sc is a bioinformatics analysis pipeline that leverages single-cell sequencing data to estimate cell type proportion and cell type-specific gene expression differences from RNA-seq data from bulk tissue samples. This is a companion package to the publication "A single-cell transcriptomic map of the human and mouse pancreas reveals inter- and intra-cell population structure." Baron et al. Cell Systems (2016) https://www.ncbi.nlm.nih.gov/pubmed/27667365.
MOSAIK is a program for mapping second and third-generation sequencing reads to a reference genome. MOSAIK can align reads generated by all the major sequencing technologies, including Illumina, Applied Biosystems SOLiD, Roche 454, Ion Torrent and Pacific BioSciences SMRT.
This package provides a collection of useful functions for working with DNA methylation micro-array data.
Picard is a set of Java command line tools for manipulating high-throughput sequencing (HTS) data and formats. Picard is implemented using the HTSJDK Java library to support accessing file formats that are commonly used for high-throughput sequencing data such as SAM, BAM, CRAM and VCF.
Jellyfish is a tool for fast, memory-efficient counting of k-mers in DNA. A k-mer is a substring of length k, and counting the occurrences of all such substrings is a central step in many analyses of DNA sequence. Jellyfish is a command-line program that reads FASTA and multi-FASTA files containing DNA sequences. It outputs its k-mer counts in a binary format, which can be translated into a human-readable text format using the jellyfish dump command, or queried for specific k-mers with jellyfish query.
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.
BWA is a software package for mapping low-divergent sequences against a large reference genome, such as the human genome. It consists of three algorithms: BWA-backtrack, BWA-SW and BWA-MEM. The first algorithm is designed for Illumina sequence reads up to 100bp, while the rest two for longer sequences ranged from 70bp to 1Mbp. BWA-MEM and BWA-SW share similar features such as long-read support and split alignment, but BWA-MEM, which is the latest, is generally recommended for high-quality queries as it is faster and more accurate. BWA-MEM also has better performance than BWA-backtrack for 70-100bp Illumina reads.
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.
This package provides an automated pipeline for spatial mapping of unique transcripts.
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.
A tandem repeat in DNA is two or more adjacent, approximate copies of a pattern of nucleotides. Tandem Repeats Finder is a program to locate and display tandem repeats in DNA sequences. In order to use the program, the user submits a sequence in FASTA format. The output consists of two files: a repeat table file and an alignment file. Submitted sequences may be of arbitrary length. Repeats with pattern size in the range from 1 to 2000 bases are detected.
Cell2cell is a Python library for cell communication analysis. This is a method to calculate, visualize and analyze communication between cell types. Cell2cell is suitable for single-cell RNA sequencing (scRNA-seq) data.
PiGx is a collection of genomics pipelines. It includes the following pipelines:
PiGx BSseq for raw fastq read data of bisulfite experiments
PiGx RNAseq for RNAseq samples
PiGx scRNAseq for single cell dropseq analysis
PiGx ChIPseq for reads from ChIPseq experiments
All pipelines are easily configured with a simple sample sheet and a descriptive settings file. The result is a set of comprehensive, interactive HTML reports with interesting findings about your samples.
This package provides a client for the OmniPath web service and many other resources. It also includes functions to transform and pretty print some of the downloaded data, functions to access a number of other resources such as BioPlex, ConsensusPathDB, EVEX, Gene Ontology, Guide to Pharmacology (IUPHAR/BPS), Harmonizome, HTRIdb, Human Phenotype Ontology, InWeb InBioMap, KEGG Pathway, Pathway Commons, Ramilowski et al. 2015, RegNetwork, ReMap, TF census, TRRUST and Vinayagam et al. 2011. Furthermore, OmnipathR features a close integration with the NicheNet method for ligand activity prediction from transcriptomics data, and its R implementation nichenetr.
FLASH (Fast Length Adjustment of SHort reads) is a tool to merge paired-end reads from next-generation sequencing experiments. FLASH is designed to merge pairs of reads when the original DNA fragments are shorter than twice the length of reads. The resulting longer reads can significantly improve genome assemblies. They can also improve transcriptome assembly when FLASH is used to merge RNA-seq data.
This package provides different statistical methods to extract biological activities from omics data within a unified framework.
Sjcount is a utility for fast quantification of splice junctions in RNA-seq data. It is annotation-agnostic and offset-aware. This version does count multisplits.
R-scape discovers RNA secondary structure consensus elements. These elements include riboswitches and ribozymes. It utilizes probabilistic modeling of sequence alignments, explicitly considering folding dependencies. The tool enables the de novo search for new structural elements and facilitates comparative analysis of known RNA families.
bx-python provides tools for manipulating biological data, particularly multiple sequence alignments.
eXpress is a streaming tool for quantifying the abundances of a set of target sequences from sampled subsequences. Example applications include transcript-level RNA-Seq quantification, allele-specific/haplotype expression analysis (from RNA-Seq), transcription factor binding quantification in ChIP-Seq, and analysis of metagenomic data.
LoFreq is a fast and sensitive variant-caller for inferring SNVs and indels from next-generation sequencing data. It makes full use of base-call qualities and other sources of errors inherent in sequencing (e.g. mapping or base/indel alignment uncertainty), which are usually ignored by other methods or only used for filtering.