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.
The phylo module provides a biojava interface layer to the forester phylogenomics library for constructing phylogenetic trees.
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.
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.
t-Stochastic Neighborhood Embedding (t-SNE) is a method for dimensionality reduction and visualization of high dimensional datasets. A popular implementation of t-SNE uses the Barnes-Hut algorithm to approximate the gradient at each iteration of gradient descent. This implementation differs in these ways:
Instead of approximating the N-body simulation using Barnes-Hut, we interpolate onto an equispaced grid and use FFT to perform the convolution.
Instead of computing nearest neighbors using vantage-point trees, we approximate nearest neighbors using the Annoy library. The neighbor lookups are multithreaded to take advantage of machines with multiple cores.
This package provides a simple web interface for the RNA-centric annotation system (RCAS).
Circe is a Python package for inferring co-accessibility networks from single-cell ATAC-seq data, using skggm for the graphical lasso and python-scanpy for data processing.
BWA-PSSM is a probabilistic short genomic sequence read aligner based on the use of position specific scoring matrices (PSSM). Like many of the existing aligners it is fast and sensitive. Unlike most other aligners, however, it is also adaptible in the sense that one can direct the alignment based on known biases within the data set. It is coded as a modification of the original BWA alignment program and shares the genome index structure as well as many of the command line options.
This package provides R miscellaneous utilities for basic data manipulation, debugging, visualization, lsf management, and common mskilab tasks.
The package reads phylogenetic data in the phyloXML format. It also includes functions for writing data in this format.
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.
FAN-C provides a pipeline for analysing Hi-C data starting at mapped paired-end sequencing reads.
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.
SlamDunk is a fully automated tool for automated, robust, scalable and reproducible SLAMseq data analysis. Diagnostic plotting features and a MultiQC plugin will make your SLAMseq data ready for immediate QA and interpretation.
METAL is a tool for meta-analysis genomewide association scans. METAL can combine either test statistics and standard errors or p-values across studies (taking sample size and direction of effect into account). METAL analysis is a convenient alternative to a direct analysis of merged data from multiple studies. It is especially appropriate when data from the individual studies cannot be analyzed together because of differences in ethnicity, phenotype distribution, gender or constraints in sharing of individual level data imposed. Meta-analysis results in little or no loss of efficiency compared to analysis of a combined dataset including data from all individual studies.
This package lets you perform unsupervised clustering of amplicon sequencing data in microbiome studies with the Dirichlet-tree Multinomial Mixtures.
This package provides different statistical methods to extract biological activities from omics data within a unified framework.
Pando leverages multi-modal single-cell measurements to infer gene regulatory networks using a flexible linear model-based framework. By modeling the relationship between TF-binding site pairs with the expression of target genes, Pando simultaneously infers gene modules and sets of regulatory regions for each transcription factor.
The Spliced Transcripts Alignment to a Reference (STAR) software is based on a previously undescribed RNA-seq alignment algorithm that uses sequential maximum mappable seed search in uncompressed suffix arrays followed by seed clustering and stitching procedure. In addition to unbiased de novo detection of canonical junctions, STAR can discover non-canonical splices and chimeric (fusion) transcripts, and is also capable of mapping full-length RNA sequences.
MAFFT offers a range of multiple alignment methods for nucleotide and protein sequences. For instance, it offers L-INS-i (accurate; for alignment of <~200 sequences) and FFT-NS-2 (fast; for alignment of <~30,000 sequences).
NGS is a domain-specific API for accessing reads, alignments and pileups produced from Next Generation Sequencing. The API itself is independent from any particular back-end implementation, and supports use of multiple back-ends simultaneously.
HMMER is used for searching sequence databases for homologs of protein sequences, and for making protein sequence alignments. It implements methods using probabilistic models called profile hidden Markov models (profile HMMs).
MultiVelo uses a probabilistic latent variable model to estimate the switch time and rate parameters of gene regulation, providing a quantitative summary of the temporal relationship between epigenomic and transcriptomic changes.
ChIPKernels is an R package for building different string kernels used for DNA Sequence analysis. A dictionary of the desired kernel must be built and this dictionary can be used for determining kernels for DNA Sequences.
SeqAn is a C++ library of efficient algorithms and data structures for the analysis of sequences with the focus on biological data. It contains algorithms and data structures for string representation and their manipulation, online and indexed string search, efficient I/O of bioinformatics file formats, sequence alignment, and more.