_            _    _        _         _
      /\ \         /\ \ /\ \     /\_\      / /\
      \_\ \       /  \ \\ \ \   / / /     / /  \
      /\__ \     / /\ \ \\ \ \_/ / /     / / /\ \__
     / /_ \ \   / / /\ \ \\ \___/ /     / / /\ \___\
    / / /\ \ \ / / /  \ \_\\ \ \_/      \ \ \ \/___/
   / / /  \/_// / /   / / / \ \ \        \ \ \
  / / /      / / /   / / /   \ \ \   _    \ \ \
 / / /      / / /___/ / /     \ \ \ /_/\__/ / /
/_/ /      / / /____\/ /       \ \_\\ \/___/ /
\_\/       \/_________/         \/_/ \_____\/
r-numbat 1.4.2
Propagated dependencies: r-ape@5.8-1 r-catools@1.18.3 r-data-table@1.17.4 r-dendextend@1.19.0 r-dplyr@1.1.4 r-genomicranges@1.60.0 r-ggplot2@3.5.2 r-ggraph@2.2.1 r-ggtree@3.16.0 r-glue@1.8.0 r-hahmmr@1.0.0 r-igraph@2.1.4 r-iranges@2.42.0 r-logger@0.4.0 r-magrittr@2.0.3 r-matrix@1.7-3 r-optparse@1.7.5 r-paralleldist@0.2.6 r-patchwork@1.3.0 r-pryr@0.1.6 r-purrr@1.0.4 r-r-utils@2.13.0 r-rcpp@1.0.14 r-rcpparmadillo@14.4.3-1 r-rhpcblasctl@0.23-42 r-roptim@0.1.6 r-scales@1.4.0 r-scistreer@1.2.0 r-stringr@1.5.1 r-tibble@3.2.1 r-tidygraph@1.3.1 r-tidyr@1.3.1 r-vcfr@1.15.0 r-zoo@1.8-14
Channel: guix
Location: gnu/packages/bioconductor.scm (gnu packages bioconductor)
Home page: https://github.com/kharchenkolab/numbat
Licenses: Expat
Synopsis: Haplotype-aware CNV analysis from scRNA-Seq
Description:

This package provides a computational method that infers copy number variations (CNV) in cancer scRNA-seq data and reconstructs the tumor phylogeny. It integrates signals from gene expression, allelic ratio, and population haplotype structures to accurately infer allele-specific CNVs in single cells and reconstruct their lineage relationship. It does not require tumor/normal-paired DNA or genotype data, but operates solely on the donor scRNA-data data (for example, 10x Cell Ranger output). It can be used to:

  1. detect allele-specific copy number variations from single-cells

  2. differentiate tumor versus normal cells in the tumor microenvironment

  3. infer the clonal architecture and evolutionary history of profiled tumors

For details on the method see Gao et al in Nature Biotechnology 2022.

r-ttgsea 1.18.0
Channel: guix-bioc
Location: guix-bioc/packages/t.scm (guix-bioc packages t)
Home page: https://bioconductor.org/packages/ttgsea
Licenses: Artistic License 2.0
Synopsis: Tokenizing Text of Gene Set Enrichment Analysis
Description:

Functional enrichment analysis methods such as gene set enrichment analysis (GSEA) have been widely used for analyzing gene expression data. GSEA is a powerful method to infer results of gene expression data at a level of gene sets by calculating enrichment scores for predefined sets of genes. GSEA depends on the availability and accuracy of gene sets. There are overlaps between terms of gene sets or categories because multiple terms may exist for a single biological process, and it can thus lead to redundancy within enriched terms. In other words, the sets of related terms are overlapping. Using deep learning, this pakage is aimed to predict enrichment scores for unique tokens or words from text in names of gene sets to resolve this overlapping set issue. Furthermore, we can coin a new term by combining tokens and find its enrichment score by predicting such a combined tokens.

r-udpipe 0.8.11
Propagated dependencies: r-data-table@1.17.4 r-matrix@1.7-3 r-rcpp@1.0.14
Channel: guix-science
Location: guix-science/packages/cran.scm (guix-science packages cran)
Home page: https://bnosac.github.io/udpipe/en/index.html
Licenses: MPL 2.0
Synopsis: R bindings for UDPipe NLP toolkit
Description:

This natural language processing toolkit provides language-agnostic tokenization, parts of speech tagging, lemmatization and dependency parsing of raw text. Next to text parsing, the package also allows you to train annotation models based on data of treebanks in CoNLL-U format as provided at https://universaldependencies.org/format.html. The techniques are explained in detail in the paper: 'Tokenizing, POS Tagging, Lemmatizing and Parsing UD 2.0 with UDPipe', available at doi:10.18653/v1/K17-3009. The toolkit also contains functionalities for commonly used data manipulations on texts which are enriched with the output of the parser. Namely functionalities and algorithms for collocations, token co-occurrence, document term matrix handling, term frequency inverse document frequency calculations, information retrieval metrics (Okapi BM25), handling of multi-word expressions, keyword detection (Rapid Automatic Keyword Extraction, noun phrase extraction, syntactical patterns) sentiment scoring and semantic similarity analysis.

r-scgate 1.7.0
Propagated dependencies: r-biocparallel@1.42.0 r-dplyr@1.1.4 r-ggplot2@3.5.2 r-ggridges@0.5.6 r-patchwork@1.3.0 r-reshape2@1.4.4 r-seurat@5.3.0 r-ucell@2.12.0
Channel: guix
Location: gnu/packages/bioconductor.scm (gnu packages bioconductor)
Home page: https://github.com/carmonalab/scGate
Licenses: GPL 3
Synopsis: Marker-based cell type purification for single-cell sequencing data
Description:

This package provides a method to purify a cell type or cell population of interest from heterogeneous datasets. scGate package automatizes marker-based purification of specific cell populations, without requiring training data or reference gene expression profiles. scGate takes as input a gene expression matrix stored in a Seurat object and a GM, consisting of a set of marker genes that define the cell population of interest. It evaluates the strength of signature marker expression in each cell using the rank-based method UCell, and then performs kNN smoothing by calculating the mean UCell score across neighboring cells. kNN-smoothing aims at compensating for the large degree of sparsity in scRNAseq data. Finally, a universal threshold over kNN-smoothed signature scores is applied in binary decision trees generated from the user-provided gating model, to annotate cells as either “pure” or “impure”, with respect to the cell population of interest.

r-mistyr 1.18.0
Channel: guix-bioc
Location: guix-bioc/packages/m.scm (guix-bioc packages m)
Home page: https://saezlab.github.io/mistyR/
Licenses: GPL 3
Synopsis: Multiview Intercellular SpaTial modeling framework
Description:

mistyR is an implementation of the Multiview Intercellular SpaTialmodeling framework (MISTy). MISTy is an explainable machine learning framework for knowledge extraction and analysis of single-cell, highly multiplexed, spatially resolved data. MISTy facilitates an in-depth understanding of marker interactions by profiling the intra- and intercellular relationships. MISTy is a flexible framework able to process a custom number of views. Each of these views can describe a different spatial context, i.e., define a relationship among the observed expressions of the markers, such as intracellular regulation or paracrine regulation, but also, the views can also capture cell-type specific relationships, capture relations between functional footprints or focus on relations between different anatomical regions. Each MISTy view is considered as a potential source of variability in the measured marker expressions. Each MISTy view is then analyzed for its contribution to the total expression of each marker and is explained in terms of the interactions with other measurements that led to the observed contribution.

r-tronco 2.42.0
Channel: guix-bioc
Location: guix-bioc/packages/t.scm (guix-bioc packages t)
Home page: https://sites.google.com/site/troncopackage/
Licenses: GPL 3
Synopsis: TRONCO, an R package for TRanslational ONCOlogy
Description:

The TRONCO (TRanslational ONCOlogy) R package collects algorithms to infer progression models via the approach of Suppes-Bayes Causal Network, both from an ensemble of tumors (cross-sectional samples) and within an individual patient (multi-region or single-cell samples). The package provides parallel implementation of algorithms that process binary matrices where each row represents a tumor sample and each column a single-nucleotide or a structural variant driving the progression; a 0/1 value models the absence/presence of that alteration in the sample. The tool can import data from plain, MAF or GISTIC format files, and can fetch it from the cBioPortal for cancer genomics. Functions for data manipulation and visualization are provided, as well as functions to import/export such data to other bioinformatics tools for, e.g, clustering or detection of mutually exclusive alterations. Inferred models can be visualized and tested for their confidence via bootstrap and cross-validation. TRONCO is used for the implementation of the Pipeline for Cancer Inference (PICNIC).

r-ppcseq 1.18.0
Channel: guix-bioc
Location: guix-bioc/packages/p.scm (guix-bioc packages p)
Home page: https://github.com/stemangiola/ppcseq
Licenses: GPL 3
Synopsis: Probabilistic Outlier Identification for RNA Sequencing Generalized Linear Models
Description:

Relative transcript abundance has proven to be a valuable tool for understanding the function of genes in biological systems. For the differential analysis of transcript abundance using RNA sequencing data, the negative binomial model is by far the most frequently adopted. However, common methods that are based on a negative binomial model are not robust to extreme outliers, which we found to be abundant in public datasets. So far, no rigorous and probabilistic methods for detection of outliers have been developed for RNA sequencing data, leaving the identification mostly to visual inspection. Recent advances in Bayesian computation allow large-scale comparison of observed data against its theoretical distribution given in a statistical model. Here we propose ppcseq, a key quality-control tool for identifying transcripts that include outlier data points in differential expression analysis, which do not follow a negative binomial distribution. Applying ppcseq to analyse several publicly available datasets using popular tools, we show that from 3 to 10 percent of differentially abundant transcripts across algorithms and datasets had statistics inflated by the presence of outliers.

r-qusage 2.44.0
Channel: guix-bioc
Location: guix-bioc/packages/q.scm (guix-bioc packages q)
Home page: http://clip.med.yale.edu/qusage
Licenses: GPL 2+
Synopsis: qusage: Quantitative Set Analysis for Gene Expression
Description:

This package is an implementation the Quantitative Set Analysis for Gene Expression (QuSAGE) method described in (Yaari G. et al, Nucl Acids Res, 2013). This is a novel Gene Set Enrichment-type test, which is designed to provide a faster, more accurate, and easier to understand test for gene expression studies. qusage accounts for inter-gene correlations using the Variance Inflation Factor technique proposed by Wu et al. (Nucleic Acids Res, 2012). In addition, rather than simply evaluating the deviation from a null hypothesis with a single number (a P value), qusage quantifies gene set activity with a complete probability density function (PDF). From this PDF, P values and confidence intervals can be easily extracted. Preserving the PDF also allows for post-hoc analysis (e.g., pair-wise comparisons of gene set activity) while maintaining statistical traceability. Finally, while qusage is compatible with individual gene statistics from existing methods (e.g., LIMMA), a Welch-based method is implemented that is shown to improve specificity. The QuSAGE package also includes a mixed effects model implementation, as described in (Turner JA et al, BMC Bioinformatics, 2015), and a meta-analysis framework as described in (Meng H, et al. PLoS Comput Biol. 2019). For questions, contact Chris Bolen (cbolen1@gmail.com) or Steven Kleinstein (steven.kleinstein@yale.edu).

r-rgenoud 5.9-0.11
Channel: guix
Location: gnu/packages/cran.scm (gnu packages cran)
Home page: https://github.com/JasjeetSekhon/rgenoud
Licenses: GPL 3
Synopsis: R version of genetic optimization using derivatives
Description:

This package provides a genetic algorithm plus derivative optimizer.

rust-ring 0.17.8
Channel: guix
Location: gnu/packages/rust-sources.scm (gnu packages rust-sources)
Home page: https://github.com/briansmith/ring
Licenses: ISC OpenSSL
Synopsis: Safe, fast, small crypto using Rust
Description:

This package provided safe, fast, small crypto using Rust.

r-pd-rice 3.12.0
Propagated dependencies: r-s4vectors@0.46.0 r-rsqlite@2.3.11 r-oligoclasses@1.70.0 r-oligo@1.72.0 r-iranges@2.42.0 r-dbi@1.2.3 r-biostrings@2.76.0
Channel: guix-bioc
Location: guix-bioc/packages/p.scm (guix-bioc packages p)
Home page: https://bioconductor.org/packages/pd.rice
Licenses: Artistic License 2.0
Synopsis: Platform Design Info for The Manufacturer's Name Rice
Description:

Platform Design Info for The Manufacturer's Name Rice.

ruby-rotp 6.2.0
Channel: gn-bioinformatics
Location: gn/packages/ruby.scm (gn packages ruby)
Home page: https://github.com/mdp/rotp
Licenses: Expat
Synopsis: Works for both HOTP and TOTP, and includes QR Code provisioning
Description:

Works for both HOTP and TOTP, and includes QR Code provisioning

r-r-utils 2.13.0
Propagated dependencies: r-r-methodss3@1.8.2 r-r-oo@1.27.1
Channel: guix
Location: gnu/packages/statistics.scm (gnu packages statistics)
Home page: https://github.com/HenrikBengtsson/R.utils
Licenses: LGPL 2.1+
Synopsis: Various programming utilities
Description:

This package provides utility functions useful when programming and developing R packages.

r-rafalib 1.0.4
Propagated dependencies: r-biocmanager@1.30.25 r-rcolorbrewer@1.1-3
Channel: guix
Location: gnu/packages/cran.scm (gnu packages cran)
Home page: https://cran.r-project.org/package=rafalib
Licenses: Artistic License 2.0
Synopsis: Convenience functions for routine data exploration
Description:

This package provides a series of shortcuts for routine tasks to facilitate data exploration.

r-ricecdf 2.18.0
Propagated dependencies: r-annotationdbi@1.70.0
Channel: guix-bioc
Location: guix-bioc/packages/r.scm (guix-bioc packages r)
Home page: https://bioconductor.org/packages/ricecdf
Licenses: LGPL 2.0+
Synopsis: ricecdf
Description:

This package provides a package containing an environment representing the Rice.cdf file.

r-rnbeads 2.26.0
Dependencies: kentutils@302.0.0
Propagated dependencies: r-biocgenerics@0.54.0 r-cluster@2.1.8.1 r-ff@4.5.2 r-fields@16.3.1 r-genomicranges@1.60.0 r-ggplot2@3.5.2 r-gplots@3.2.0 r-gridextra@2.3 r-illuminaio@0.50.0 r-iranges@2.42.0 r-limma@3.64.1 r-mass@7.3-65 r-matrixstats@1.5.0 r-methylumi@2.54.0 r-plyr@1.8.9 r-s4vectors@0.46.0
Channel: guix
Location: gnu/packages/bioconductor.scm (gnu packages bioconductor)
Home page: https://bioconductor.org/packages/RnBeads
Licenses: GPL 3
Synopsis: RnBeads
Description:

RnBeads facilitates comprehensive analysis of various types of DNA methylation data at the genome scale.

ruby-rake 13.3.0
Channel: guix
Location: gnu/packages/ruby-check.scm (gnu packages ruby-check)
Home page: https://github.com/ruby/rake
Licenses: Expat
Synopsis: Rake is a Make-like program implemented in Ruby
Description:

Rake is a Make-like program where tasks and dependencies are specified in standard Ruby syntax.

ruby-roda 3.57.0
Propagated dependencies: ruby-rack@2.2.7
Channel: guix
Location: gnu/packages/ruby-xyz.scm (gnu packages ruby-xyz)
Home page: https://roda.jeremyevans.net
Licenses: Expat
Synopsis: Routing Tree Web Toolkit
Description:

Roda is a routing tree web toolkit, designed for building fast and maintainable web applications in ruby.

ruby-racc 1.5.2
Channel: guix
Location: gnu/packages/ruby-xyz.scm (gnu packages ruby-xyz)
Home page: https://i.loveruby.net/en/projects/racc/
Licenses: LGPL 2.1 Ruby License
Synopsis: LALR(1) parser generator for Ruby
Description:

Racc is a LALR(1) parser generator. It is written in Ruby itself, and generates Ruby program.

r-reshape 0.8.9
Propagated dependencies: r-plyr@1.8.9
Channel: guix
Location: gnu/packages/cran.scm (gnu packages cran)
Home page: http://had.co.nz/reshape
Licenses: Expat
Synopsis: Flexibly reshape data
Description:

Flexibly restructure and aggregate data using just two functions: melt and cast. This package provides them.

r-rainbow 3.8
Propagated dependencies: r-cluster@2.1.8.1 r-colorspace@2.1-1 r-hdrcde@3.4 r-ks@1.15.1 r-mass@7.3-65 r-pcapp@2.0-5
Channel: guix
Location: gnu/packages/cran.scm (gnu packages cran)
Home page: https://cran.r-project.org/web/packages/rainbow/
Licenses: GPL 3
Synopsis: Bagplots, boxplots and rainbow plots for functional data
Description:

This is a package for visualizing functional data and identifying functional outliers with bagplots, boxplots and rainbow plots.

r-rtopper 1.56.0
Propagated dependencies: r-multtest@2.64.0 r-limma@3.64.1 r-biobase@2.68.0
Channel: guix-bioc
Location: guix-bioc/packages/r.scm (guix-bioc packages r)
Home page: https://bioconductor.org/packages/RTopper
Licenses: FSDG-compatible
Synopsis: This package is designed to perform Gene Set Analysis across multiple genomic platforms
Description:

the RTopper package is designed to perform and integrate gene set enrichment results across multiple genomic platforms.

ruby-reek 6.0.3
Propagated dependencies: ruby-kwalify@0.7.2 ruby-parser@3.3.7.0 ruby-psych@3.3.0 ruby-rainbow@3.0.0
Channel: gn-bioinformatics
Location: gn/packages/ruby.scm (gn packages ruby)
Home page: https://github.com/troessner/reek
Licenses: Expat
Synopsis: Reek is a tool that examines Ruby classes, modules and methods and reports any code smells it finds.
Description:

Reek is a tool that examines Ruby classes, modules and methods and reports any code smells it finds.

r-rticles 0.27
Propagated dependencies: r-knitr@1.50 r-lifecycle@1.0.4 r-rmarkdown@2.29 r-tinytex@0.57 r-xfun@0.52 r-yaml@2.3.10
Channel: guix
Location: gnu/packages/cran.scm (gnu packages cran)
Home page: https://github.com/rstudio/rticles
Licenses: GPL 3
Synopsis: Article formats for R Markdown
Description:

This package provides a suite of custom R Markdown formats and templates for authoring journal articles and conference submissions.

Total results: 7783