_            _    _        _         _
      /\ \         /\ \ /\ \     /\_\      / /\
      \_\ \       /  \ \\ \ \   / / /     / /  \
      /\__ \     / /\ \ \\ \ \_/ / /     / / /\ \__
     / /_ \ \   / / /\ \ \\ \___/ /     / / /\ \___\
    / / /\ \ \ / / /  \ \_\\ \ \_/      \ \ \ \/___/
   / / /  \/_// / /   / / / \ \ \        \ \ \
  / / /      / / /   / / /   \ \ \   _    \ \ \
 / / /      / / /___/ / /     \ \ \ /_/\__/ / /
/_/ /      / / /____\/ /       \ \_\\ \/___/ /
\_\/       \/_________/         \/_/ \_____\/
r-osta-data 1.0.0
Propagated dependencies: r-osfr@0.2.9 r-biocfilecache@2.16.0
Channel: guix-bioc
Location: guix-bioc/packages/o.scm (guix-bioc packages o)
Home page: https://github.com/estellad/OSTA.data
Licenses: Artistic License 2.0
Synopsis: OSTA book data
Description:

OSTA.data is a companion package for the "Orchestrating Spatial Transcriptomics Analysis" (OSTA) with Bioconductor online book. Throughout OSTA, we rely on a set of publicly available datasets that cover different sequencing- and imaging-based platforms, such as Visium, Visium HD, Xenium (10x Genomics) and CosMx (NanoString). In addition, we rely on scRNA-seq (Chromium) data for tasks, e.g., spot deconvolution and label transfer (i.e., supervised clustering). These data been deposited in an Open Storage Framework (OSF) repository, and can be queried and downloaded using functions from the osfr package. For convenience, we have implemented OSTA.data to query and retrieve data from our OSF node, and cache retrieved Zip archives using BiocFileCache'.

r-momentfit 0.5
Propagated dependencies: r-sandwich@3.1-1
Channel: guix-cran
Location: guix-cran/packages/m.scm (guix-cran packages m)
Home page: https://cran.r-project.org/package=momentfit
Licenses: GPL 2+
Synopsis: Methods of Moments
Description:

Several classes for moment-based models are defined. The classes are defined for moment conditions derived from a single equation or a system of equations. The conditions can also be expressed as functions or formulas. Several methods are also offered to facilitate the development of different estimation techniques. The methods that are currently provided are the Generalized method of moments (Hansen 1982; <doi:10.2307/1912775>), for single equations and systems of equation, and the Generalized Empirical Likelihood (Smith 1997; <doi:10.1111/j.0013-0133.1997.174.x>, Kitamura 1997; <doi:10.1214/aos/1069362388>, Newey and Smith 2004; <doi:10.1111/j.1468-0262.2004.00482.x>, and Anatolyev 2005 <doi:10.1111/j.1468-0262.2005.00601.x>).

r-powerlate 0.1.2
Channel: guix-cran
Location: guix-cran/packages/p.scm (guix-cran packages p)
Home page: https://github.com/kbansak/powerLATE_tutorial
Licenses: GPL 2+
Synopsis: Generalized Power Analysis for LATE
Description:

An implementation of the generalized power analysis for the local average treatment effect (LATE), proposed by Bansak (2020) <doi:10.1214/19-STS732>. Power analysis is in the context of estimating the LATE (also known as the complier average causal effect, or CACE), with calculations based on a test of the null hypothesis that the LATE equals 0 with a two-sided alternative. The method uses standardized effect sizes to place a conservative bound on the power under minimal assumptions. Package allows users to recover power, sample size requirements, or minimum detectable effect sizes. Package also allows users to work with absolute effects rather than effect sizes, to specify an additional assumption to narrow the bounds, and to incorporate covariate adjustment.

r-sparsepca 0.1.2
Propagated dependencies: r-rsvd@1.0.5
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/erichson/spca
Licenses: GPL 3+
Synopsis: Sparse Principal Component Analysis (SPCA)
Description:

Sparse principal component analysis (SPCA) attempts to find sparse weight vectors (loadings), i.e., a weight vector with only a few active (nonzero) values. This approach provides better interpretability for the principal components in high-dimensional data settings. This is, because the principal components are formed as a linear combination of only a few of the original variables. This package provides efficient routines to compute SPCA. Specifically, a variable projection solver is used to compute the sparse solution. In addition, a fast randomized accelerated SPCA routine and a robust SPCA routine is provided. Robust SPCA allows to capture grossly corrupted entries in the data. The methods are discussed in detail by N. Benjamin Erichson et al. (2018) <arXiv:1804.00341>.

r-timevtree 0.3.1
Propagated dependencies: r-survival@3.8-3
Channel: guix-cran
Location: guix-cran/packages/t.scm (guix-cran packages t)
Home page: https://cran.r-project.org/package=TimeVTree
Licenses: GPL 2
Synopsis: Survival Analysis of Time Varying Coefficients Using a Tree-Based Approach
Description:

Estimates time varying regression effects under Cox type models in survival data using classification and regression tree. The codes in this package were originally written in S-Plus for the paper "Survival Analysis with Time-Varying Regression Effects Using a Tree-Based Approach," by Xu, R. and Adak, S. (2002) <doi:10.1111/j.0006-341X.2002.00305.x>, Biometrics, 58: 305-315. Development of this package was supported by NIH grants AG053983 and AG057707, and by the UCSD Altman Translational Research Institute, NIH grant UL1TR001442. The content is solely the responsibility of the authors and does not necessarily represent the official views of the NIH. The example data are from the Honolulu Heart Program/Honolulu Asia Aging Study (HHP/HAAS).

r-orfhunter 1.16.0
Propagated dependencies: r-xfun@0.52 r-stringr@1.5.1 r-rtracklayer@1.68.0 r-rcpp@1.0.14 r-randomforest@4.7-1.2 r-peptides@2.4.6 r-data-table@1.17.2 r-bsgenome-hsapiens-ucsc-hg38@1.4.5 r-biostrings@2.76.0
Channel: guix-bioc
Location: guix-bioc/packages/o.scm (guix-bioc packages o)
Home page: https://bioconductor.org/packages/ORFhunteR
Licenses: FSDG-compatible
Synopsis: Predict open reading frames in nucleotide sequences
Description:

The ORFhunteR package is a R and C++ library for an automatic determination and annotation of open reading frames (ORF) in a large set of RNA molecules. It efficiently implements the machine learning model based on vectorization of nucleotide sequences and the random forest classification algorithm. The ORFhunteR package consists of a set of functions written in the R language in conjunction with C++. The efficiency of the package was confirmed by the examples of the analysis of RNA molecules from the NCBI RefSeq and Ensembl databases. The package can be used in basic and applied biomedical research related to the study of the transcriptome of normal as well as altered (for example, cancer) human cells.

r-ggstudent 0.1.2
Propagated dependencies: r-ggplot2@3.5.2 r-dplyr@1.1.4
Channel: guix-cran
Location: guix-cran/packages/g.scm (guix-cran packages g)
Home page: https://github.com/helske/ggstudent
Licenses: GPL 2+
Synopsis: Continuous Confidence Interval Plots using t-Distribution
Description:

This package provides an extension to ggplot2 (Wickham, 2016, <doi:10.1007/978-3-319-24277-4>) for creating two types of continuous confidence interval plots (Violin CI and Gradient CI plots), typically for the sample mean. These plots contain multiple user-defined confidence areas with varying colours, defined by the underlying t-distribution used to compute standard confidence intervals for the mean of the normal distribution when the variance is unknown. Two types of plots are available, a gradient plot with rectangular areas, and a violin plot where the shape (horizontal width) is defined by the probability density function of the t-distribution. These visualizations are studied in (Helske, Helske, Cooper, Ynnerman, and Besancon, 2021) <doi:10.1109/TVCG.2021.3073466>.

r-gdalcubes 0.7.1
Dependencies: zlib@1.3 sqlite@3.39.3 proj@9.3.1 pcre2@10.42 openssl@3.0.8 openssh@10.0p1 netcdf@4.9.0 gdal@3.8.2 curl@8.6.0
Propagated dependencies: r-rcpp@1.0.14 r-ncdf4@1.24 r-jsonlite@2.0.0 r-bh@1.87.0-1
Channel: guix-cran
Location: guix-cran/packages/g.scm (guix-cran packages g)
Home page: https://github.com/appelmar/gdalcubes
Licenses: Expat
Synopsis: Earth Observation Data Cubes from Satellite Image Collections
Description:

Processing collections of Earth observation images as on-demand multispectral, multitemporal raster data cubes. Users define cubes by spatiotemporal extent, resolution, and spatial reference system and let gdalcubes automatically apply cropping, reprojection, and resampling using the Geospatial Data Abstraction Library ('GDAL'). Implemented functions on data cubes include reduction over space and time, applying arithmetic expressions on pixel band values, moving window aggregates over time, filtering by space, time, bands, and predicates on pixel values, exporting data cubes as netCDF or GeoTIFF files, plotting, and extraction from spatial and or spatiotemporal features. All computational parts are implemented in C++, linking to the GDAL', netCDF', CURL', and SQLite libraries. See Appel and Pebesma (2019) <doi:10.3390/data4030092> for further details.

r-metevalue 0.2.4
Propagated dependencies: r-sqldf@0.4-11 r-psych@2.5.3 r-dplyr@1.1.4
Channel: guix-cran
Location: guix-cran/packages/m.scm (guix-cran packages m)
Home page: https://cran.r-project.org/package=metevalue
Licenses: FSDG-compatible
Synopsis: E-Value in the Omics Data Association Studies
Description:

In the omics data association studies, it is common to conduct the p-value corrections to control the false significance. Beyond the P-value corrections, E-value is recently studied to facilitate multiple testing correction based on V. Vovk and R. Wang (2021) <doi:10.1214/20-AOS2020>. This package provides E-value calculation for DNA methylation data and RNA-seq data. Currently, five data formats are supported: DNA methylation levels using DMR detection tools (BiSeq, DMRfinder, MethylKit, Metilene and other DNA methylation tools) and RNA-seq data. The relevant references are listed below: Katja Hebestreit and Hans-Ulrich Klein (2022) <doi:10.18129/B9.bioc.BiSeq>; Altuna Akalin et.al (2012) <doi:10.18129/B9.bioc.methylKit>.

r-nndiagram 1.0.0
Propagated dependencies: r-dplyr@1.1.4
Channel: guix-cran
Location: guix-cran/packages/n.scm (guix-cran packages n)
Home page: https://github.com/ccfang2/nndiagram
Licenses: Expat
Synopsis: Generator of 'LaTeX' Code for Drawing Neural Network Diagrams with 'TikZ'
Description:

Generates LaTeX code for drawing well-formatted neural network diagrams with TikZ'. Users have to define number of neurons on each layer, and optionally define neuron connections they would like to keep or omit, layers they consider to be oversized and neurons they would like to draw with lighter color. They can also specify the title of diagram, color, opacity of figure, labels of layers, input and output neurons. In addition, this package helps to produce LaTeX code for drawing activation functions which are crucial in neural network analysis. To make the code work in a LaTeX editor, users need to install and import some TeX packages including TikZ in the setting of TeX file.

r-ppitables 0.6.0
Propagated dependencies: r-tidyr@1.3.1 r-tibble@3.2.1
Channel: guix-cran
Location: guix-cran/packages/p.scm (guix-cran packages p)
Home page: https://github.com/katilingban/ppitables
Licenses: Expat
Synopsis: Lookup Tables to Generate Poverty Likelihoods and Rates using the Poverty Probability Index (PPI)
Description:

The Poverty Probability Index (PPI) is a poverty measurement tool for organizations and businesses with a mission to serve the poor. The PPI is statistically-sound, yet simple to use: the answers to 10 questions about a household's characteristics and asset ownership are scored to compute the likelihood that the household is living below the poverty line - or above by only a narrow margin. This package contains country-specific lookup data tables used as reference to determine the poverty likelihood of a household based on their score from the country-specific PPI questionnaire. These lookup tables have been extracted from documentation of the PPI found at <https://www.povertyindex.org> and managed by Innovations for Poverty Action <https://poverty-action.org/>.

r-prnsamplr 1.1.0
Propagated dependencies: r-rlang@1.1.6
Channel: guix-cran
Location: guix-cran/packages/p.scm (guix-cran packages p)
Home page: https://cran.r-project.org/package=prnsamplr
Licenses: Expat
Synopsis: Permanent Random Number Sampling
Description:

Survey sampling using permanent random numbers (PRN's). A solution to the problem of unknown overlap between survey samples, which leads to a low precision in estimates when the survey is repeated or combined with other surveys. The PRN solution is to supply the U(0, 1) random numbers to the sampling procedure, instead of having the sampling procedure generate them. In Lindblom (2014) <doi:10.2478/jos-2014-0047>, and therein cited papers, it is shown how this is carried out and how it improves the estimates. This package supports two common fixed-size sampling procedures (simple random sampling and probability-proportional-to-size sampling) and includes a function for transforming the PRN's in order to control the sample overlap.

r-packetllm 0.1.0
Propagated dependencies: r-shinyjs@2.1.0 r-shiny@1.10.0 r-readtext@0.91 r-promises@1.3.2 r-pdftools@3.5.0 r-httr@1.4.7 r-future@1.49.0
Channel: guix-cran
Location: guix-cran/packages/p.scm (guix-cran packages p)
Home page: https://github.com/AntoniCzolgowski/PacketLLM
Licenses: Expat
Synopsis: Interactive 'OpenAI' Model Integration in 'RStudio'
Description:

Offers an interactive RStudio gadget interface for communicating with OpenAI large language models (e.g., gpt-4o', gpt-4o-mini', gpt-4.1', o1', o3-mini') (<https://platform.openai.com/docs/api-reference>). Enables users to conduct multiple chat conversations simultaneously in separate tabs. Supports uploading local files (R, PDF, DOCX) to provide context for the models. Allows per-conversation configuration of model parameters such as temperature and system messages (where supported by the model). API interactions via the httr package are performed asynchronously using promises and future to avoid blocking the R console. Useful for tasks like code generation, text summarization, and document analysis directly within the RStudio environment. Requires an OpenAI API key set as an environment variable.

r-quicseedr 0.1.2
Propagated dependencies: r-wrs2@1.1-6 r-tidyselect@1.2.1 r-tidyr@1.3.1 r-rlang@1.1.6 r-readxl@1.4.5 r-magrittr@2.0.3 r-ggplot2@3.5.2 r-dplyr@1.1.4
Channel: guix-cran
Location: guix-cran/packages/q.scm (guix-cran packages q)
Home page: https://cran.r-project.org/package=QuICSeedR
Licenses: GPL 3 FSDG-compatible
Synopsis: Analyze Data for Fluorophore-Assisted Seed Amplification Assays
Description:

This package provides a toolkit for analysis and visualization of data from fluorophore-assisted seed amplification assays, such as Real-Time Quaking-Induced Conversion (RT-QuIC) and Fluorophore-Assisted Protein Misfolding Cyclic Amplification (PMCA). QuICSeedR addresses limitations in existing software by automating data processing, supporting large-scale analysis, and enabling comparative studies of analysis methods. It incorporates methods described in Henderson et al. (2015) <doi:10.1099/vir.0.069906-0>, Li et al. (2020) <doi:10.1038/s41598-021-96127-8>, Rowden et al. (2023) <doi:10.3390/pathogens12020309>, Haley et al. (2013) <doi:10.1371/journal.pone.0081488>, and Mair and Wilcox (2020) <doi:10.3758/s13428-019-01246-w>. Please refer to the original publications for details.

r-synthetic 1.1.0
Propagated dependencies: r-rlang@1.1.6 r-magrittr@2.0.3 r-ggplot2@3.5.2 r-dplyr@1.1.4
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/agi-lab/SynthETIC
Licenses: GPL 3
Synopsis: Synthetic Experience Tracking Insurance Claims
Description:

Creation of an individual claims simulator which generates various features of non-life insurance claims. An initial set of test parameters, designed to mirror the experience of an Auto Liability portfolio, were set up and applied by default to generate a realistic test data set of individual claims (see vignette). The simulated data set then allows practitioners to back-test the validity of various reserving models and to prove and/or disprove certain actuarial assumptions made in claims modelling. The distributional assumptions used to generate this data set can be easily modified by users to match their experiences. Reference: Avanzi B, Taylor G, Wang M, Wong B (2020) "SynthETIC: an individual insurance claim simulator with feature control" <arXiv:2008.05693>.

r-simplybee 0.4.1
Propagated dependencies: r-rcpparmadillo@14.4.2-1 r-rcpp@1.0.14 r-rann@2.6.2 r-r6@2.6.1 r-extradistr@1.10.0 r-bh@1.87.0-1 r-alphasimr@1.6.1
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/HighlanderLab/SIMplyBee
Licenses: Expat
Synopsis: 'AlphaSimR' Extension for Simulating Honeybee Populations and Breeding Programmes
Description:

An extension of the AlphaSimR package (<https://cran.r-project.org/package=AlphaSimR>) for stochastic simulations of honeybee populations and breeding programmes. SIMplyBee enables simulation of individual bees that form a colony, which includes a queen, fathers (drones the queen mated with), virgin queens, workers, and drones. Multiple colony can be merged into a population of colonies, such as an apiary or a whole country of colonies. Functions enable operations on castes, colony, or colonies, to ease R scripting of whole populations. All AlphaSimR functionality with respect to genomes and genetic and phenotype values is available and further extended for honeybees, including haplo-diploidy, complementary sex determiner locus, colony events (swarming, supersedure, etc.), and colony phenotype values.

r-rspectral 1.0.0.10
Propagated dependencies: r-rdpack@2.6.4 r-rcpparmadillo@14.4.2-1 r-rcpp@1.0.14 r-igraph@2.1.4 r-graph@1.86.0
Channel: guix-cran
Location: guix-cran/packages/r.scm (guix-cran packages r)
Home page: https://github.com/cmclean5/rSpectral
Licenses: GPL 2
Synopsis: Spectral Modularity Clustering
Description:

This package implements the network clustering algorithm described in Newman (2006) <doi:10.1103/PhysRevE.74.036104>. The complete iterative algorithm comprises of two steps. In the first step, the network is expressed in terms of its leading eigenvalue and eigenvector and recursively partition into two communities. Partitioning occurs if the maximum positive eigenvalue is greater than the tolerance (10e-5) for the current partition, and if it results in a positive contribution to the Modularity. Given an initial separation using the leading eigen step, rSpectral then continues to maximise for the change in Modularity using a fine-tuning step - or variate thereof. The first stage here is to find the node which, when moved from one community to another, gives the maximum change in Modularity. This nodeâ s community is then fixed and we repeat the process until all nodes have been moved. The whole process is repeated from this new state until the change in the Modularity, between the new and old state, is less than the predefined tolerance. A slight variant of the fine-tuning step, which can improve speed of the calculation, is also provided. Instead of moving each node into each community in turn, we only consider moves of neighbouring nodes, found in different communities, to the community of the current node of interest. The two steps process is repeatedly applied to each new community found, subdivided each community into two new communities, until we are unable to find any division that results in a positive change in Modularity.

r-cbassed50 0.2.0
Propagated dependencies: r-rlog@0.1.0 r-readxl@1.4.5 r-glue@1.8.0 r-ggplot2@3.5.2 r-drc@3.0-1 r-dplyr@1.1.4
Channel: guix-cran
Location: guix-cran/packages/c.scm (guix-cran packages c)
Home page: https://cran.r-project.org/package=CBASSED50
Licenses: Expat
Synopsis: Process CBASS-Derived PAM Data
Description:

This package provides tools to process CBASS-derived PAM data efficiently. Minimal requirements are PAM-based photosynthetic efficiency data (or data from any other continuous variable that changes with temperature, e.g. relative bleaching scores) from 4 coral samples (nubbins) subjected to 4 temperature profiles of at least 2 colonies from 1 coral species from 1 site. Please refer to the following CBASS (Coral Bleaching Automated Stress System) papers for in-depth information regarding CBASS acute thermal stress assays, experimental design considerations, and ED5/ED50/ED95 thermal parameters: Nicolas R. Evensen et al. (2023) <doi:10.1002/lom3.10555> Christian R. Voolstra et al. (2020) <doi:10.1111/gcb.15148> Christian R. Voolstra et al. (2025) <doi:10.1146/annurev-marine-032223-024511>.

r-crm12comb 0.1.11
Propagated dependencies: r-ggplot2@3.5.2 r-ggforce@0.4.2 r-dplyr@1.1.4
Channel: guix-cran
Location: guix-cran/packages/c.scm (guix-cran packages c)
Home page: https://cran.r-project.org/package=crm12Comb
Licenses: GPL 3+
Synopsis: Phase I/II CRM Based Drug Combination Design
Description:

This package implements the adaptive designs for integrated phase I/II trials of drug combinations via continual reassessment method (CRM) to evaluate toxicity and efficacy simultaneously for each enrolled patient cohort based on Bayesian inference. It supports patients assignment guidance in a single trial using current enrolled data, as well as conducting extensive simulation studies to evaluate operating characteristics before the trial starts. It includes various link functions such as empiric, one-parameter logistic, two-parameter logistic, and hyperbolic tangent, as well as considering multiple prior distributions of the parameters like normal distribution, gamma distribution and exponential distribution to accommodate diverse clinical scenarios. Method using Bayesian framework with empiric link function is described in: Wages and Conaway (2014) <doi:10.1002/sim.6097>.

r-formulaic 0.0.8
Propagated dependencies: r-data-table@1.17.2
Channel: guix-cran
Location: guix-cran/packages/f.scm (guix-cran packages f)
Home page: https://dachosen1.github.io/formulaic/index.html
Licenses: GPL 3
Synopsis: Dynamic Generation and Quality Checks of Formula Objects
Description:

Many statistical models and analyses in R are implemented through formula objects. The formulaic package creates a unified approach for programmatically and dynamically generating formula objects. Users may specify the outcome and inputs of a model directly, search for variables to include based upon naming patterns, incorporate interactions, and identify variables to exclude. A wide range of quality checks are implemented to identify issues such as misspecified variables, duplication, a lack of contrast in the inputs, and a large number of levels in categorical data. Variables that do not meet these quality checks can be automatically excluded from the model. These issues are documented and reported in a manner that provides greater accountability and useful information to guide an investigation of the data.

r-piggyback 0.1.5
Propagated dependencies: r-memoise@2.0.1 r-lubridate@1.9.4 r-jsonlite@2.0.0 r-httr@1.4.7 r-glue@1.8.0 r-gh@1.4.1 r-fs@1.6.6 r-cli@3.6.5
Channel: guix-cran
Location: guix-cran/packages/p.scm (guix-cran packages p)
Home page: https://github.com/ropensci/piggyback
Licenses: GPL 3
Synopsis: Managing Larger Data on a GitHub Repository
Description:

Because larger (> 50 MB) data files cannot easily be committed to git, a different approach is required to manage data associated with an analysis in a GitHub repository. This package provides a simple work-around by allowing larger (up to 2 GB) data files to piggyback on a repository as assets attached to individual GitHub releases. These files are not handled by git in any way, but instead are uploaded, downloaded, or edited directly by calls through the GitHub API. These data files can be versioned manually by creating different releases. This approach works equally well with public or private repositories. Data can be uploaded and downloaded programmatically from scripts. No authentication is required to download data from public repositories.

r-pdtoolkit 1.2.0
Propagated dependencies: r-rpart@4.1.24 r-monobin@0.2.4 r-dplyr@1.1.4
Channel: guix-cran
Location: guix-cran/packages/p.scm (guix-cran packages p)
Home page: https://github.com/andrija-djurovic/PDtoolkit
Licenses: GPL 3+
Synopsis: Collection of Tools for PD Rating Model Development and Validation
Description:

The goal of this package is to cover the most common steps in probability of default (PD) rating model development and validation. The main procedures available are those that refer to univariate, bivariate, multivariate analysis, calibration and validation. Along with accompanied monobin and monobinShiny packages, PDtoolkit provides functions which are suitable for different data transformation and modeling tasks such as: imputations, monotonic binning of numeric risk factors, binning of categorical risk factors, weights of evidence (WoE) and information value (IV) calculations, WoE coding (replacement of risk factors modalities with WoE values), risk factor clustering, area under curve (AUC) calculation and others. Additionally, package provides set of validation functions for testing homogeneity, heterogeneity, discriminatory and predictive power of the model.

r-tealeaves 1.0.6
Propagated dependencies: r-units@0.8-7 r-stringr@1.5.1 r-rlang@1.1.6 r-purrr@1.0.4 r-magrittr@2.0.3 r-glue@1.8.0 r-future@1.49.0 r-furrr@0.3.1 r-dplyr@1.1.4 r-crayon@1.5.3 r-checkmate@2.3.2
Channel: guix-cran
Location: guix-cran/packages/t.scm (guix-cran packages t)
Home page: https://cran.r-project.org/package=tealeaves
Licenses: Expat
Synopsis: Solve for Leaf Temperature Using Energy Balance
Description:

This package implements models of leaf temperature using energy balance. It uses units to ensure that parameters are properly specified and transformed before calculations. It allows separate lower and upper surface conductances to heat and water vapour, so sensible and latent heat loss are calculated for each surface separately as in Foster and Smith (1986) <doi:10.1111/j.1365-3040.1986.tb02108.x>. It's straightforward to model leaf temperature over environmental gradients such as light, air temperature, humidity, and wind. It can also model leaf temperature over trait gradients such as leaf size or stomatal conductance. Other references are Monteith and Unsworth (2013, ISBN:9780123869104), Nobel (2009, ISBN:9780123741431), and Okajima et al. (2012) <doi:10.1007/s11284-011-0905-5>.

r-scinsight 0.1.4
Propagated dependencies: r-stringr@1.5.1 r-rcpparmadillo@14.4.2-1 r-rcpp@1.0.14 r-rann@2.6.2 r-igraph@2.1.4
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/Vivianstats/scINSIGHT
Licenses: GPL 3
Synopsis: Interpretation of Heterogeneous Single-Cell Gene Expression Data
Description:

We develop a novel matrix factorization tool named scINSIGHT to jointly analyze multiple single-cell gene expression samples from biologically heterogeneous sources, such as different disease phases, treatment groups, or developmental stages. Given multiple gene expression samples from different biological conditions, scINSIGHT simultaneously identifies common and condition-specific gene modules and quantify their expression levels in each sample in a lower-dimensional space. With the factorized results, the inferred expression levels and memberships of common gene modules can be used to cluster cells and detect cell identities, and the condition-specific gene modules can help compare functional differences in transcriptomes from distinct conditions. Please also see Qian K, Fu SW, Li HW, Li WV (2022) <doi:10.1186/s13059-022-02649-3>.

Page: 1234567891011121314151617181920212223242526272829303132333435363738394041424344454647484950515253545556575859606162636465666768697071727374757677787980818283848586878889909192939495969798991001011021031041051061071081091101111121131141151161171181191201211221231241251261271281291301311321331341351361371381391401411421431441451461471481491501511521531541551561571581591601611621631641651661671681691701711721731741751761771781791801811821831841851861871881891901911921931941951961971981992002012022032042052062072082092102112122132142152162172182192202212222232242252262272282292302312322332342352362372382392402412422432442452462472482492502512522532542552562572582592602612622632642652662672682692702712722732742752762772782792802812822832842852862872882892902912922932942952962972982993003013023033043053063073083093103113123133143153163173183193203213223233243253263273283293303313323333343353363373383393403413423433443453463473483493503513523533543553563573583593603613623633643653663673683693703713723733743753763773783793803813823833843853863873883893903913923933943953963973983994004014024034044054064074084094104114124134144154164174184194204214224234244254264274284294304314324334344354364374384394404414424434444454464474484494504514524534544554564574584594604614624634644654664674684694704714724734744754764774784794804814824834844854864874884894904914924934944954964974984995005015025035045055065075085095105115125135145155165175185195205215225235245255265275285295305315325335345355365375385395405415425435445455465475485495505515525535545555565575585595605615625635645655665675685695705715725735745755765775785795805815825835845855865875885895905915925935945955965975985996006016026036046056066076086096106116126136146156166176186196206216226236246256266276286296306316326336346356366376386396406416426436446456466476486496506516526536546556566576586596606616626636646656666676686696706716726736746756766776786796806816826836846856866876886896906916926936946956966976986997007017027037047057067077087097107117127137147157167177187197207217227237247257267277287297307317327337347357367377387397407417427437447457467477487497507517527537547557567577587597607617627637647657667677687697707717727737747757767777787797807817827837847857867877887897907917927937947957967977987998008018028038048058068078088098108118128138148158168178188198208218228238248258268278288298308318328338348358368378388398408418428438448458468478488498508518528538548558568578588598608618628638648658668678688698708718728738748758768778788798808818828838848858868878888898908918928938948958968978988999009019029039049059069079089099109119129139149159169179189199209219229239249259269279289299309319329339349359369379389399409419429439449459469479489499509519529539549559569579589599609619629639649659669679689699709719729739749759769779789799809819829839849859869879889899909919929939949959969979989991000100110021003100410051006100710081009101010111012101310141015101610171018101910201021102210231024102510261027102810291030103110321033103410351036103710381039104010411042104310441045104610471048104910501051105210531054105510561057105810591060106110621063106410651066106710681069107010711072107310741075107610771078107910801081108210831084108510861087108810891090109110921093109410951096109710981099110011011102110311041105110611071108110911101111111211131114111511161117111811191120112111221123112411251126112711281129113011311132113311341135113611371138113911401141114211431144114511461147114811491150115111521153115411551156115711581159116011611162116311641165116611671168116911701171117211731174117511761177117811791180118111821183118411851186118711881189119011911192119311941195119611971198119912001201120212031204120512061207120812091210121112121213121412151216121712181219122012211222122312241225122612271228122912301231123212331234123512361237123812391240124112421243124412451246124712481249125012511252125312541255125612571258125912601261126212631264126512661267126812691270127112721273127412751276127712781279128012811282128312841285128612871288128912901291129212931294129512961297129812991300130113021303130413051306130713081309131013111312131313141315131613171318131913201321132213231324132513261327132813291330133113321333133413351336133713381339134013411342134313441345134613471348134913501351135213531354135513561357135813591360136113621363136413651366136713681369137013711372137313741375137613771378137913801381138213831384138513861387138813891390139113921393139413951396139713981399140014011402140314041405140614071408140914101411141214131414141514161417141814191420142114221423142414251426142714281429143014311432143314341435143614371438143914401441144214431444144514461447144814491450145114521453145414551456145714581459146014611462146314641465146614671468146914701471147214731474147514761477147814791480148114821483148414851486148714881489149014911492149314941495149614971498149915001501150215031504150515061507150815091510151115121513151415151516151715181519152015211522152315241525152615271528
Total results: 36659