_            _    _        _         _
      /\ \         /\ \ /\ \     /\_\      / /\
      \_\ \       /  \ \\ \ \   / / /     / /  \
      /\__ \     / /\ \ \\ \ \_/ / /     / / /\ \__
     / /_ \ \   / / /\ \ \\ \___/ /     / / /\ \___\
    / / /\ \ \ / / /  \ \_\\ \ \_/      \ \ \ \/___/
   / / /  \/_// / /   / / / \ \ \        \ \ \
  / / /      / / /   / / /   \ \ \   _    \ \ \
 / / /      / / /___/ / /     \ \ \ /_/\__/ / /
/_/ /      / / /____\/ /       \ \_\\ \/___/ /
\_\/       \/_________/         \/_/ \_____\/

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.


r-sangeranalyser 1.20.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/sangeranalyseR
Licenses: GPL 2
Synopsis: sangeranalyseR: a suite of functions for the analysis of Sanger sequence data in R
Description:

This package builds on sangerseqR to allow users to create contigs from collections of Sanger sequencing reads. It provides a wide range of options for a number of commonly-performed actions including read trimming, detecting secondary peaks, and detecting indels using a reference sequence. All parameters can be adjusted interactively either in R or in the associated Shiny applications. There is extensive online documentation, and the package can outputs detailed HTML reports, including chromatograms.

r-switchde 1.36.0
Propagated dependencies: r-summarizedexperiment@1.38.1 r-singlecellexperiment@1.30.1 r-ggplot2@3.5.2 r-dplyr@1.1.4
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/kieranrcampbell/switchde
Licenses: GPL 2+
Synopsis: Switch-like differential expression across single-cell trajectories
Description:

Inference and detection of switch-like differential expression across single-cell RNA-seq trajectories.

r-snphooddata 1.40.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/SNPhoodData
Licenses: LGPL 3+
Synopsis: Additional and more complex example data for the SNPhood package
Description:

This companion package for SNPhood provides some example datasets of a larger size than allowed for the SNPhood package. They include full and real-world examples for performing analyses with the SNPhood package.

r-shinyepico 1.18.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/omorante/shiny_epico
Licenses: FSDG-compatible
Synopsis: ShinyÉPICo
Description:

ShinyÉPICo is a graphical pipeline to analyze Illumina DNA methylation arrays (450k or EPIC). It allows to calculate differentially methylated positions and differentially methylated regions in a user-friendly interface. Moreover, it includes several options to export the results and obtain files to perform downstream analysis.

r-svp 1.2.1
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/YuLab-SMU/SVP
Licenses: GPL 3
Synopsis: Predicting cell states and their variability in single-cell or spatial omics data
Description:

SVP uses the distance between cells and cells, features and features, cells and features in the space of MCA to build nearest neighbor graph, then uses random walk with restart algorithm to calculate the activity score of gene sets (such as cell marker genes, kegg pathway, go ontology, gene modules, transcription factor or miRNA target sets, reactome pathway, ...), which is then further weighted using the hypergeometric test results from the original expression matrix. To detect the spatially or single cell variable gene sets or (other features) and the spatial colocalization between the features accurately, SVP provides some global and local spatial autocorrelation method to identify the spatial variable features. SVP is developed based on SingleCellExperiment class, which can be interoperable with the existing computing ecosystem.

r-scthi 1.22.0
Propagated dependencies: r-rtsne@0.17 r-biocparallel@1.42.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/scTHI
Licenses: GPL 2
Synopsis: Indentification of significantly activated ligand-receptor interactions across clusters of cells from single-cell RNA sequencing data
Description:

scTHI is an R package to identify active pairs of ligand-receptors from single cells in order to study,among others, tumor-host interactions. scTHI contains a set of signatures to classify cells from the tumor microenvironment.

r-sparrow 1.16.0
Propagated dependencies: r-viridis@0.6.5 r-plotly@4.10.4 r-matrix@1.7-3 r-limma@3.64.1 r-irlba@2.3.5.1 r-gseabase@1.70.0 r-ggplot2@3.5.2 r-edger@4.6.2 r-delayedmatrixstats@1.30.0 r-data-table@1.17.4 r-complexheatmap@2.24.0 r-circlize@0.4.16 r-checkmate@2.3.2 r-biocset@1.22.0 r-biocparallel@1.42.0 r-biocgenerics@0.54.0 r-babelgene@22.9
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/lianos/sparrow
Licenses: Expat
Synopsis: Take command of set enrichment analyses through a unified interface
Description:

This package provides a unified interface to a variety of GSEA techniques from different bioconductor packages. Results are harmonized into a single object and can be interrogated uniformly for quick exploration and interpretation of results. Interactive exploration of GSEA results is enabled through a shiny app provided by a sparrow.shiny sibling package.

r-splots 1.76.0
Propagated dependencies: r-rcolorbrewer@1.1-3
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/splots
Licenses: LGPL 2.0+
Synopsis: Visualization of high-throughput assays in microtitre plate or slide format
Description:

This package is here to support legacy usages of it, but it should not be used for new code development. It provides a single function, plotScreen, for visualising data in microtitre plate or slide format. As a better alternative for such functionality, please consider the platetools package on CRAN (https://cran.r-project.org/package=platetools and https://github.com/Swarchal/platetools), or ggplot2 (geom_raster, facet_wrap) as exemplified in the vignette of this package.

r-sitepath 1.26.0
Propagated dependencies: r-tidytree@0.4.6 r-seqinr@4.2-36 r-rcpp@1.0.14 r-rcolorbrewer@1.1-3 r-gridextra@2.3 r-ggtree@3.16.0 r-ggrepel@0.9.6 r-ggplot2@3.5.2 r-aplot@0.2.5 r-ape@5.8-1
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://wuaipinglab.github.io/sitePath/
Licenses: Expat
Synopsis: Phylogeny-based sequence clustering with site polymorphism
Description:

Using site polymorphism is one of the ways to cluster DNA/protein sequences but it is possible for the sequences with the same polymorphism on a single site to be genetically distant. This package is aimed at clustering sequences using site polymorphism and their corresponding phylogenetic trees. By considering their location on the tree, only the structurally adjacent sequences will be clustered. However, the adjacent sequences may not necessarily have the same polymorphism. So a branch-and-bound like algorithm is used to minimize the entropy representing the purity of site polymorphism of each cluster.

r-saser 1.6.0
Propagated dependencies: r-summarizedexperiment@1.38.1 r-s4vectors@0.46.0 r-prroc@1.4 r-matrixgenerics@1.20.0 r-mass@7.3-65 r-limma@3.64.1 r-iranges@2.42.0 r-igraph@2.1.4 r-genomicranges@1.60.0 r-genomicfeatures@1.60.0 r-genomicalignments@1.44.0 r-edger@4.6.2 r-dplyr@1.1.4 r-deseq2@1.48.1 r-data-table@1.17.4 r-biocparallel@1.42.0 r-biocgenerics@0.54.0 r-aspli@2.18.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/statOmics/saseR
Licenses: Artistic License 2.0
Synopsis: Scalable Aberrant Splicing and Expression Retrieval
Description:

saseR is a highly performant and fast framework for aberrant expression and splicing analyses. The main functions are: \itemize\item \code\linkBamtoAspliCounts - Process BAM files to ASpli counts \item \code\linkconvertASpli - Get gene, bin or junction counts from ASpli SummarizedExperiment \item \code\linkcalculateOffsets - Create an offsets assays for aberrant expression or splicing analysis \item \code\linksaseRfindEncodingDim - Estimate the optimal number of latent factors to include when estimating the mean expression \item \code\linksaseRfit - Parameter estimation of the negative binomial distribution and compute p-values for aberrant expression and splicing For information upon how to use these functions, check out our vignette at \urlhttps://github.com/statOmics/saseR/blob/main/vignettes/Vignette.Rmd and the saseR paper: Segers, A. et al. (2023). Juggling offsets unlocks RNA-seq tools for fast scalable differential usage, aberrant splicing and expression analyses. bioRxiv. \urlhttps://doi.org/10.1101/2023.06.29.547014.

r-seta 1.0.0
Propagated dependencies: r-tidygraph@1.3.1 r-singlecellexperiment@1.30.1 r-rlang@1.1.6 r-matrix@1.7-3 r-mass@7.3-65 r-dplyr@1.1.4
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/kkimler/SETA
Licenses: Expat
Synopsis: Single Cell Ecological Taxonomic Analysis
Description:

This package provides tools for compositional and other sample-level ecological analyses and visualizations tailored for single-cell RNA-seq data. SETA includes functions for taxonomizing celltypes, normalizing data, performing statistical tests, and visualizing results. Several tutorials are included to guide users and introduce them to key concepts. SETA is meant to teach users about statistical concepts underlying ecological analysis methods so they can apply them to their own single-cell data.

r-sctgif 1.24.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/scTGIF
Licenses: Artistic License 2.0
Synopsis: Cell type annotation for unannotated single-cell RNA-Seq data
Description:

scTGIF connects the cells and the related gene functions without cell type label.

r-sfedata 1.12.0
Propagated dependencies: r-experimenthub@2.16.0 r-biocfilecache@2.16.0 r-annotationhub@3.16.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/pachterlab/SFEData
Licenses: Artistic License 2.0
Synopsis: Example SpatialFeatureExperiment datasets
Description:

Example spatial transcriptomics datasets with Simple Feature annotations as SpatialFeatureExperiment objects. Technologies include Visium, slide-seq, Nanostring CoxMX, Vizgen MERFISH, and 10X Xenium. Tissues include mouse skeletal muscle, human melanoma metastasis, human lung, breast cancer, and mouse liver.

r-signer 2.12.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/TojalLab/signeR
Licenses: GPL 3
Synopsis: Empirical Bayesian approach to mutational signature discovery
Description:

The signeR package provides an empirical Bayesian approach to mutational signature discovery. It is designed to analyze single nucleotide variation (SNV) counts in cancer genomes, but can also be applied to other features as well. Functionalities to characterize signatures or genome samples according to exposure patterns are also provided.

r-shinybiocloader 1.0.0
Propagated dependencies: r-shiny@1.10.0 r-htmltools@0.5.8.1
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/Bioconductor/shinybiocloader
Licenses: Artistic License 2.0
Synopsis: Use a Shiny Bioconductor CSS loader
Description:

Add a Bioconductor themed CSS loader to your shiny app. It is based on the shinycustomloader R package. Use a spinning Bioconductor note loader to enhance your shiny app loading screen. This package is intended for developer use.

r-skewr 1.42.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/skewr
Licenses: GPL 2
Synopsis: Visualize Intensities Produced by Illumina's Human Methylation 450k BeadChip
Description:

The skewr package is a tool for visualizing the output of the Illumina Human Methylation 450k BeadChip to aid in quality control. It creates a panel of nine plots. Six of the plots represent the density of either the methylated intensity or the unmethylated intensity given by one of three subsets of the 485,577 total probes. These subsets include Type I-red, Type I-green, and Type II.The remaining three distributions give the density of the Beta-values for these same three subsets. Each of the nine plots optionally displays the distributions of the "rs" SNP probes and the probes associated with imprinted genes as series of tick marks located above the x-axis.

r-svm2crmdata 1.42.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/SVM2CRMdata
Licenses: LGPL 2.0+
Synopsis: An example dataset for use with the SVM2CRM package
Description:

An example dataset for use with the SVM2CRM package.

r-spatialcpie 1.26.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/SpatialCPie
Licenses: Expat
Synopsis: Cluster analysis of Spatial Transcriptomics data
Description:

SpatialCPie is an R package designed to facilitate cluster evaluation for spatial transcriptomics data by providing intuitive visualizations that display the relationships between clusters in order to guide the user during cluster identification and other downstream applications. The package is built around a shiny "gadget" to allow the exploration of the data with multiple plots in parallel and an interactive UI. The user can easily toggle between different cluster resolutions in order to choose the most appropriate visual cues.

r-sights 1.36.0
Propagated dependencies: r-reshape2@1.4.4 r-qvalue@2.40.0 r-mass@7.3-65 r-lattice@0.22-7 r-ggplot2@3.5.2
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://eg-r.github.io/sights/
Licenses: GPL 3 FSDG-compatible
Synopsis: Statistics and dIagnostic Graphs for HTS
Description:

SIGHTS is a suite of normalization methods, statistical tests, and diagnostic graphical tools for high throughput screening (HTS) assays. HTS assays use microtitre plates to screen large libraries of compounds for their biological, chemical, or biochemical activity.

r-scrnaseqapp 1.10.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://github.com/jianhong/scRNAseqApp
Licenses: GPL 3
Synopsis: single-cell RNAseq Shiny app-package
Description:

The scRNAseqApp is a Shiny app package designed for interactive visualization of single-cell data. It is an enhanced version derived from the ShinyCell, repackaged to accommodate multiple datasets. The app enables users to visualize data containing various types of information simultaneously, facilitating comprehensive analysis. Additionally, it includes a user management system to regulate database accessibility for different users.

r-semdist 1.44.0
Propagated dependencies: r-go-db@3.21.0 r-annotationdbi@1.70.0 r-annotate@1.86.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: http://github.com/iangonzalez/SemDist
Licenses: GPL 2+
Synopsis: Information Accretion-based Function Predictor Evaluation
Description:

This package implements methods to calculate information accretion for a given version of the gene ontology and uses this data to calculate remaining uncertainty, misinformation, and semantic similarity for given sets of predicted annotations and true annotations from a protein function predictor.

r-spari 1.0.0
Propagated dependencies: r-summarizedexperiment@1.38.1 r-spatialexperiment@1.18.1 r-rcpp@1.0.14 r-matrix@1.7-3 r-biocparallel@1.42.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/spARI
Licenses: GPL 2+
Synopsis: Spatially Aware Adjusted Rand Index for Evaluating Spatial Transcritpomics Clustering
Description:

The R package used in the manuscript "Spatially Aware Adjusted Rand Index for Evaluating Spatial Transcritpomics Clustering".

r-sechm 1.18.0
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/sechm
Licenses: GPL 3
Synopsis: sechm: Complex Heatmaps from a SummarizedExperiment
Description:

sechm provides a simple interface between SummarizedExperiment objects and the ComplexHeatmap package. It enables plotting annotated heatmaps from SE objects, with easy access to rowData and colData columns, and implements a number of features to make the generation of heatmaps easier and more flexible. These functionalities used to be part of the SEtools package.

r-sampleclassifierdata 1.34.0
Propagated dependencies: r-summarizedexperiment@1.38.1
Channel: guix-bioc
Location: guix-bioc/packages/s.scm (guix-bioc packages s)
Home page: https://bioconductor.org/packages/sampleClassifierData
Licenses: Artistic License 2.0
Synopsis: Pre-processed data for use with the sampleClassifier package
Description:

This package contains two microarray and two RNA-seq datasets that have been preprocessed for use with the sampleClassifier package. The RNA-seq data are derived from Fagerberg et al. (2014) and the Illumina Body Map 2.0 data. The microarray data are derived from Roth et al. (2006) and Ge et al. (2005).

Total results: 1535