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 SCDE package implements a set of statistical methods for analyzing single-cell RNA-seq data. SCDE fits individual error models for single-cell RNA-seq measurements. These models can then be used for assessment of differential expression between groups of cells, as well as other types of analysis. The SCDE package also contains the pagoda framework which applies pathway and gene set overdispersion analysis to identify aspects of transcriptional heterogeneity among single cells.
This package builds on Seurat's Doheatmap function code to produce a heatmap from a Seurat object with multiple annotation bars.
This package provides a tool for identifying and removing doublets in single-cell RNA-seq data.
This package provides a Python environment for phylogenetic tree exploration.
Model-based Analysis of Genome-wide CRISPR-Cas9 Knockout (MAGeCK) is a computational tool to identify important genes from the recent genome-scale CRISPR-Cas9 knockout screens technology. Its features include:
Simple, easy to use pipeline to screen genes in Genome-wide CRISPR-Cas9 Knockout experiments;
High sensitivity and low false discovery rate;
Fully utilize the screening data by performing both positive and negative screening in one dataset;
Provide statistical evaluation in genes, sgRNAs and pathways;
Require as few as 2 samples;
Identify cell-type specific targets;
A set of visualization features that generate publication standard figures.
This package provides a deconvolution based on Single Nucleotide Position (SNP) for multiplexed scRNA-seq data. The name vireo stand for Variational Inference for Reconstructing Ensemble Origin by expressed SNPs in multiplexed scRNA-seq data and follows the clone identification from single-cell data named cardelino.
This package provides a a transcriptomic-based framework to dissect cell communication in a global manner. It integrates an original expert-curated database of ligand-receptor interactions taking into account multiple subunits expression. Based on transcriptomic profiles (gene expression), this package computes communication scores between cells and provides several visualization modes that can be helpful to dig into cell-cell interaction mechanism and extend biological knowledge.
This package provides three libraries used by applications for analyzing PacBio genomic sequences. This library contains three sub-libraries: pbdata, hdf and alignment.
The data within this package is a panel of four samples, each with 3000 cells. There are two samples which are bone marrow (BM), and two samples which are cord blood (CB).
This package contains data used by pagoda2. The data within this package are the 3000 bone marrow cells used for vignettes.
Splicekit is a modular platform for splicing analysis from short-read RNA-seq datasets. The platform also integrates pybio for genomic operations and scanRBP for RNA-protein binding studies. The whole analysis is self-contained (one single directory) and the platform is written in Python, in a modular way.
python-cwl-utils provides python utilities and autogenerated classes for loading and parsing CWL v1.0, CWL v1.1, and CWL v1.2 documents.
F-Seq is a software package that generates a continuous tag sequence density estimation allowing identification of biologically meaningful sites such as transcription factor binding sites (ChIP-seq) or regions of open chromatin (DNase-seq). Output can be displayed directly in the UCSC Genome Browser.
ngshmmalign is a profile HMM aligner for NGS reads designed particularly for small genomes (such as those of RNA viruses like HIV-1 and HCV) that experience substantial biological insertions and deletions.
ParDRe is a parallel tool to remove duplicate genetic sequence reads. Duplicate reads can be seen as identical or nearly identical sequences with some mismatches. This tool lets users avoid the analysis of unnecessary reads, reducing the time of subsequent procedures with the dataset (e.g. assemblies, mappings, etc.). The tool is implemented with MPI in order to exploit the parallel capabilities of multicore clusters. It is faster than multithreaded counterparts (end of 2015) for the same number of cores and, thanks to the message-passing technology, it can be executed on clusters.
Biosoup is a C++ collection of header-only data structures used for storage and logging in bioinformatics tools.
Kallisto is a program for quantifying abundances of transcripts from RNA-Seq data, or more generally of target sequences using high-throughput sequencing reads. It is based on the novel idea of pseudoalignment for rapidly determining the compatibility of reads with targets, without the need for alignment. Pseudoalignment of reads preserves the key information needed for quantification, and kallisto is therefore not only fast, but also as accurate as existing quantification tools.
Implementation of the Smith-Waterman algorithm.
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.
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.
SCENIC (Single-cell regulatory network inference and clustering) is an R package to infer Gene Regulatory Networks and cell types from single-cell RNA-seq data.
Salad is a schema language for describing JSON or YAML structured linked data documents. Salad schema describes rules for preprocessing, structural validation, and hyperlink checking for documents described by a Salad schema. Salad supports rich data modeling with inheritance, template specialization, object identifiers, object references, documentation generation, code generation, and transformation to RDF. Salad provides a bridge between document and record oriented data modeling and the Semantic Web.
The R package rareMETALS2 is an extension of the R package rareMETALS. It was designed to meta-analyze gene-level association tests for binary trait. While rareMETALS offers a near-complete solution for meta-analysis of gene-level tests for quantitative trait, it does not offer the optimal solution for binary trait. The package rareMETALS2 offers improved features for analyzing gene-level association tests in meta-analyses for binary trait.
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.