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 goal of bedtorch is to provide a fast BED file manipulation tool suite native in R.
Segemehl is software to map short sequencer reads to reference genomes. Segemehl implements a matching strategy based on enhanced suffix arrays (ESA). It accepts fasta and fastq queries (gzip'ed and bgzip'ed). In addition to the alignment of reads from standard DNA- and RNA-seq protocols, it also allows the mapping of bisulfite converted reads (Lister and Cokus) and implements a split read mapping strategy. The output of segemehl is a SAM or BAM formatted alignment file.
This package contains a multicore Barnes-Hut implementation of the t-SNE algorithm. The implementation is described here: http://lvdmaaten.github.io/publications/papers/JMLR_2014.pdf.
This package is analyzing TCR and BCR sequences using unselected RNA sequencing data, profiled from fluid and solid tissues, including tumors. TRUST4 performs de novo assembly on V, J, C genes including the hypervariable CDR3 and reports consensus contigs of BCR/TCR sequences. TRUST4 then realigns the contigs to IMGT reference gene sequences to identify the corresponding gene and CDR3 details. TRUST4 supports both single-end and paired-end bulk or single-cell sequencing data with any read length.
This package provides the ASCAT R package that can be used to infer tumour purity, ploidy and allele-specific copy number profiles.
This R package provides additional capabilities and speed for GenomicRanges operations.
This package aims to bring the power and flexibility of AnnData to the R ecosystem, allowing you to effortlessly manipulate and analyze your single-cell data. This package lets you work with backed h5ad and zarr files, directly access various slots (e.g. X, obs, var), or convert the data into SingleCellExperiment and Seurat objects.
This package detects naive associations between omics features and metadata in cross-sectional data-sets using non-parametric tests. In a second step, confounding effects between metadata associated to the same omics feature are detected and labeled using nested post-hoc model comparison tests. The generated output can be graphically summarized using the built-in plotting function.
TSIS is used for detecting transcript isoform switches in time-series data. Transcript isoform switches occur when a pair of alternatively spliced isoforms reverse the order of their relative expression levels. TSIS characterizes the transcript switch by defining the isoform switch time-points for any pair of transcript isoforms within a gene. In addition, this tool describes the switch using five different features or metrics. Also it filters the results with user’s specifications and visualizes the results using different plots for the user to examine further details of the switches.
This package provides a Python module creating/accessing GTF-based interval trees with associated meta-data. It is primarily used by the deeptools package.
PAML (for Phylogentic Analysis by Maximum Likelihood) contains a few programs for model fitting and phylogenetic tree reconstruction using nucleotide or amino-acid sequence data.
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.
python-cwl-utils provides python utilities and autogenerated classes for loading and parsing CWL v1.0, CWL v1.1, and CWL v1.2 documents.
PyEGA3 is a tool for viewing and downloading files from authorized EGA datasets. It uses the EGA data API and has several key features:
Files are transferred over secure https connections and received unencrypted, so no need for decryption after download.
Downloads resume from where they left off in the event that the connection is interrupted.
Supports file segmenting and parallelized download of segments, improving overall performance.
After download completes, file integrity is verified using checksums.
Implements the GA4GH-compliant htsget protocol for download of genomic ranges for data files with accompanying index files.
PhenoGraph is a clustering method designed for high-dimensional single-cell data. It works by creating a graph representing phenotypic similarities between cells and then identifying communities in this graph.
This package Copynumber KAryotyping of Tumors infers genomic copy number and subclonal structure of human tumors using integrative Bayesian approaches to identify genome-wide aneuploidy at 5MB resolution in single cells data. It separates tumor cells and tumor subclones from normal cells using high-throughput sc-RNAseq data.
Bio++ is a set of C++ libraries for Bioinformatics, including sequence analysis, phylogenetics, molecular evolution and population genetics. This library provides sequence-related modules.
Scanorama enables batch-correction and integration of heterogeneous scRNA-seq datasets, which is described in the paper "Efficient integration of heterogeneous single-cell transcriptomes using Scanorama" by Brian Hie, Bryan Bryson, and Bonnie Berger.
The BIOM file format is designed to be a general-use format for representing counts of observations e.g. operational taxonomic units, KEGG orthology groups or lipid types, in one or more biological samples e.g. microbiome samples, genomes, metagenomes.
This package implements an algorithm which increases the number of simultaneously measurable markers and in this way helps with study of the immune responses. Thus, the present algorithm, named CytoBackBone, allows combining phenotypic information of cells from different cytometric profiles obtained from different cytometry panels. This computational approach is based on the principle that each cell has its own phenotypic and functional characteristics that can be used as an identification card. CytoBackBone uses a set of predefined markers, that we call the backbone, to define this identification card. The phenotypic information of cells with similar identification cards in the different cytometric profiles is then merged.
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.
dRep is a Python program for rapidly comparing large numbers of genomes. dRep can also "de-replicate" a genome set by identifying groups of highly similar genomes and choosing the best representative genome for each genome set.
This package implements the method csSAM that computes cell-specific differential expression from measured cell proportions using SAM.
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.