Mon, 26 Feb 2024

Package etwfe updated to version 0.4.0 with previous version 0.3.5 dated 2023-12-01

Title: Extended Two-Way Fixed Effects
Description: Convenience functions for implementing extended two-way fixed effect regressions a la Wooldridge (2021, 2022) <doi:10.2139/ssrn.3906345>, <doi:10.2139/ssrn.4183726>.
Author: Grant McDermott [aut, cre] , Frederic Kluser [ctb]
Maintainer: Grant McDermott <gmcd@amazon.com>

Diff between etwfe versions 0.3.5 dated 2023-12-01 and 0.4.0 dated 2024-02-26

 DESCRIPTION                |   10 
 MD5                        |   24 
 NAMESPACE                  |    9 
 NEWS.md                    |   15 
 R/emfx.R                   |   56 +
 R/etwfe.R                  |   56 +
 README.md                  |    9 
 inst/doc/etwfe.Rmd         |   14 
 inst/doc/etwfe.html        | 1602 ++++++++++++++++++++++-----------------------
 inst/tinytest/test_etwfe.R |  107 +--
 man/emfx.Rd                |  159 ++--
 man/etwfe.Rd               |  155 ++--
 vignettes/etwfe.Rmd        |   14 
 13 files changed, 1164 insertions(+), 1066 deletions(-)

More information about etwfe at CRAN
Permanent link

Package mcmcsae updated to version 0.7.7 with previous version 0.7.6 dated 2023-12-02

Title: Markov Chain Monte Carlo Small Area Estimation
Description: Fit multi-level models with possibly correlated random effects using Markov Chain Monte Carlo simulation. Such models allow smoothing over space and time and are useful in, for example, small area estimation.
Author: Harm Jan Boonstra [aut, cre], Grzegorz Baltissen [ctb]
Maintainer: Harm Jan Boonstra <hjboonstra@gmail.com>

Diff between mcmcsae versions 0.7.6 dated 2023-12-02 and 0.7.7 dated 2024-02-26

 mcmcsae-0.7.6/mcmcsae/man/bart.Rd                    |only
 mcmcsae-0.7.6/mcmcsae/man/mcmcsae-TMVN-method.Rd     |only
 mcmcsae-0.7.7/mcmcsae/DESCRIPTION                    |   24 
 mcmcsae-0.7.7/mcmcsae/MD5                            |  140 ++---
 mcmcsae-0.7.7/mcmcsae/NAMESPACE                      |   13 
 mcmcsae-0.7.7/mcmcsae/NEWS                           |   17 
 mcmcsae-0.7.7/mcmcsae/R/MCMCsim.R                    |   80 +--
 mcmcsae-0.7.7/mcmcsae/R/MatrixUtils.R                |   57 +-
 mcmcsae-0.7.7/mcmcsae/R/RcppExports.R                |    4 
 mcmcsae-0.7.7/mcmcsae/R/TMVN_methods.R               |   14 
 mcmcsae-0.7.7/mcmcsae/R/TMVN_sampler.R               |   27 -
 mcmcsae-0.7.7/mcmcsae/R/cMVN_sampler.R               |only
 mcmcsae-0.7.7/mcmcsae/R/cholesky.R                   |   13 
 mcmcsae-0.7.7/mcmcsae/R/conjugate_gradients.R        |  108 +---
 mcmcsae-0.7.7/mcmcsae/R/family.R                     |   74 ++
 mcmcsae-0.7.7/mcmcsae/R/formulas.R                   |   24 
 mcmcsae-0.7.7/mcmcsae/R/mc_bart.R                    |  166 +++++-
 mcmcsae-0.7.7/mcmcsae/R/mc_block.R                   |  204 ++++----
 mcmcsae-0.7.7/mcmcsae/R/mc_gen.R                     |  276 +++++++----
 mcmcsae-0.7.7/mcmcsae/R/mc_gl.R                      |    4 
 mcmcsae-0.7.7/mcmcsae/R/mc_mec.R                     |   18 
 mcmcsae-0.7.7/mcmcsae/R/mc_reg.R                     |  177 ++++---
 mcmcsae-0.7.7/mcmcsae/R/mc_vfac.R                    |   10 
 mcmcsae-0.7.7/mcmcsae/R/mc_vreg.R                    |    9 
 mcmcsae-0.7.7/mcmcsae/R/mcmcsae.R                    |    1 
 mcmcsae-0.7.7/mcmcsae/R/model_eval.R                 |   53 +-
 mcmcsae-0.7.7/mcmcsae/R/modelmatrix.R                |    4 
 mcmcsae-0.7.7/mcmcsae/R/models.R                     |  112 +++-
 mcmcsae-0.7.7/mcmcsae/R/opts.R                       |   14 
 mcmcsae-0.7.7/mcmcsae/R/parallel.R                   |   15 
 mcmcsae-0.7.7/mcmcsae/R/prediction.R                 |   14 
 mcmcsae-0.7.7/mcmcsae/R/priors.R                     |   28 -
 mcmcsae-0.7.7/mcmcsae/R/random.R                     |    8 
 mcmcsae-0.7.7/mcmcsae/R/samplers.R                   |  476 +++++++++++--------
 mcmcsae-0.7.7/mcmcsae/R/sbc.R                        |  109 +++-
 mcmcsae-0.7.7/mcmcsae/R/sparse_template.R            |  144 ++++-
 mcmcsae-0.7.7/mcmcsae/R/tabMatrix.R                  |   21 
 mcmcsae-0.7.7/mcmcsae/R/utils.R                      |   19 
 mcmcsae-0.7.7/mcmcsae/inst/doc/area_level.html       |   64 +-
 mcmcsae-0.7.7/mcmcsae/man/MCMCsim.Rd                 |    4 
 mcmcsae-0.7.7/mcmcsae/man/SBC_test.Rd                |   42 +
 mcmcsae-0.7.7/mcmcsae/man/TMVN-methods.Rd            |only
 mcmcsae-0.7.7/mcmcsae/man/aggrMatrix.Rd              |    2 
 mcmcsae-0.7.7/mcmcsae/man/anyNA-tabMatrix-method.Rd  |    2 
 mcmcsae-0.7.7/mcmcsae/man/brt.Rd                     |only
 mcmcsae-0.7.7/mcmcsae/man/correlation.Rd             |   59 ++
 mcmcsae-0.7.7/mcmcsae/man/create_TMVN_sampler.Rd     |    2 
 mcmcsae-0.7.7/mcmcsae/man/create_cMVN_sampler.Rd     |only
 mcmcsae-0.7.7/mcmcsae/man/create_sampler.Rd          |   19 
 mcmcsae-0.7.7/mcmcsae/man/gen.Rd                     |   10 
 mcmcsae-0.7.7/mcmcsae/man/gen_control.Rd             |only
 mcmcsae-0.7.7/mcmcsae/man/mcmcsae-family.Rd          |    9 
 mcmcsae-0.7.7/mcmcsae/man/mcmcsae-package.Rd         |    1 
 mcmcsae-0.7.7/mcmcsae/man/mec.Rd                     |    2 
 mcmcsae-0.7.7/mcmcsae/man/pr_MLiG.Rd                 |    2 
 mcmcsae-0.7.7/mcmcsae/man/pr_normal.Rd               |    2 
 mcmcsae-0.7.7/mcmcsae/man/read_draws.Rd              |    2 
 mcmcsae-0.7.7/mcmcsae/man/reg.Rd                     |    2 
 mcmcsae-0.7.7/mcmcsae/man/sampler_control.Rd         |   14 
 mcmcsae-0.7.7/mcmcsae/man/setup_cluster.Rd           |    2 
 mcmcsae-0.7.7/mcmcsae/man/tabMatrix-indexing.Rd      |    2 
 mcmcsae-0.7.7/mcmcsae/src/RcppExports.cpp            |    7 
 mcmcsae-0.7.7/mcmcsae/src/TN.cpp                     |   14 
 mcmcsae-0.7.7/mcmcsae/src/c_export.cpp               |    6 
 mcmcsae-0.7.7/mcmcsae/src/chMatrix.c                 |   11 
 mcmcsae-0.7.7/mcmcsae/src/mcmcsae_init.c             |  151 ++----
 mcmcsae-0.7.7/mcmcsae/src/random.cpp                 |   10 
 mcmcsae-0.7.7/mcmcsae/src/speed_ups.cpp              |   94 +--
 mcmcsae-0.7.7/mcmcsae/src/tabMatrix.cpp              |   18 
 mcmcsae-0.7.7/mcmcsae/tests/testthat/test_FH.R       |    2 
 mcmcsae-0.7.7/mcmcsae/tests/testthat/test_bart.R     |only
 mcmcsae-0.7.7/mcmcsae/tests/testthat/test_checks.R   |    7 
 mcmcsae-0.7.7/mcmcsae/tests/testthat/test_gammareg.R |    4 
 mcmcsae-0.7.7/mcmcsae/tests/testthat/test_gen.R      |    3 
 mcmcsae-0.7.7/mcmcsae/tests/testthat/test_linalg.R   |   20 
 75 files changed, 1943 insertions(+), 1123 deletions(-)

More information about mcmcsae at CRAN
Permanent link

Package FDRsamplesize2 updated to version 0.2.0 with previous version 0.1.0 dated 2023-11-27

Title: Computing Power and Sample Size for the False Discovery Rate in Multiple Applications
Description: Defines a collection of functions to compute average power and sample size for studies that use the false discovery rate as the final measure of statistical significance. A three-rectangle approximation method of a p-value histogram is proposed to derive a formula to compute the statistical power for analyses that involve the FDR. The methodology paper of this package is under review.
Author: Yonghui Ni [aut, cre], Stanley Pounds [aut]
Maintainer: Yonghui Ni <Yonghui.Ni@STJUDE.ORG>

Diff between FDRsamplesize2 versions 0.1.0 dated 2023-11-27 and 0.2.0 dated 2024-02-26

 DESCRIPTION                   |    6 -
 LICENSE                       |    2 
 MD5                           |   81 +++++++++--------
 NAMESPACE                     |   89 +++++++++----------
 NEWS.md                       |only
 R/average_power.R             |   20 ++--
 R/power.R                     |   12 +-
 R/samplesize.R                |  196 ++++++++++++++++++++++++++++++++++++------
 README.md                     |   12 ++
 man/FDRsamplesize2-package.Rd |   40 ++++----
 man/alpha.power.fdr.Rd        |    4 
 man/average.power.coxph.Rd    |    4 
 man/average.power.hart.Rd     |    2 
 man/average.power.li.Rd       |   84 +++++++++---------
 man/average.power.oneway.Rd   |   60 ++++++------
 man/average.power.ranksum.Rd  |   56 ++++++------
 man/average.power.signrank.Rd |   62 ++++++-------
 man/average.power.signtest.Rd |   56 ++++++------
 man/average.power.t.test.Rd   |   76 ++++++++--------
 man/average.power.tcorr.Rd    |   62 ++++++-------
 man/average.power.twoprop.Rd  |   62 ++++++-------
 man/fdr.avepow.Rd             |only
 man/fdr.power.alpha.Rd        |only
 man/find.sample.size.Rd       |    3 
 man/n.fdr.coxph.Rd            |    7 +
 man/n.fdr.fisher.Rd           |    4 
 man/n.fdr.negbin.Rd           |    7 +
 man/n.fdr.oneway.Rd           |   78 ++++++++--------
 man/n.fdr.poisson.Rd          |   96 ++++++++++----------
 man/n.fdr.ranksum.Rd          |   80 ++++++++---------
 man/n.fdr.signrank.Rd         |   86 +++++++++---------
 man/n.fdr.signtest.Rd         |    7 +
 man/n.fdr.tcorr.Rd            |   74 +++++++--------
 man/n.fdr.ttest.Rd            |  102 ++++++++++-----------
 man/n.fdr.twoprop.Rd          |   89 +++++++++----------
 man/power.cox.Rd              |    2 
 man/power.fisher.Rd           |   56 ++++++------
 man/power.hart.Rd             |   70 +++++++--------
 man/power.ranksum.Rd          |   62 ++++++-------
 man/power.signrank.Rd         |   68 +++++++-------
 man/power.signtest.Rd         |   62 ++++++-------
 man/power.tcorr.Rd            |   56 ++++++------
 tests/testthat.R              |   24 ++---
 43 files changed, 1099 insertions(+), 920 deletions(-)

More information about FDRsamplesize2 at CRAN
Permanent link

Package rbioacc updated to version 1.2.1 with previous version 1.2-0 dated 2023-09-21

Title: Inference and Prediction of ToxicoKinetic (TK) Models
Description: The MOSAICbioacc application is a turnkey package providing bioaccumulation factors (BCF/BMF/BSAF) from a toxicokinetic (TK) model fitted to accumulation-depuration data. It is designed to fulfil the requirements of regulators when examining applications for market authorization of active substances. See Ratier et al. (2021) <doi:10.1101/2021.09.08.459421>.
Author: Virgile Baudrot [aut, cre], Sandrine Charles [aut], Ophelia Gestin [ctb], Milena Kaag [aut], Christelle Lopes [ctb], Gauthier Multari [ctb], Alain Pave [ctb], Aude Ratier [aut], Aurelie Siberchicot [aut]
Maintainer: Virgile Baudrot <virgile.baudrot@qonfluens.com>

Diff between rbioacc versions 1.2-0 dated 2023-09-21 and 1.2.1 dated 2024-02-26

 DESCRIPTION                  |   12 
 MD5                          |   28 
 R/rbioacc-package.R          |    3 
 R/zzz_internals.R            |    2 
 README.md                    |    2 
 build/vignette.rds           |binary
 inst/doc/MWE.R               |    2 
 inst/doc/Tutorial.R          |    2 
 inst/doc/Tutorial.html       |   10 
 man/dot-is_equal_rmInf.Rd    |    4 
 man/rbioacc-package.Rd       |   28 
 src/stanExports_TK.h         | 3567 +++++++++++++++++++++----------------------
 src/stanExports_TK_predict.h | 2494 ++++++++++++++----------------
 src/stanExports_odeTK.h      | 3119 ++++++++++++++++++-------------------
 vignettes/Tutorial_files     |only
 15 files changed, 4536 insertions(+), 4737 deletions(-)

More information about rbioacc at CRAN
Permanent link

Package pagoda2 updated to version 1.0.12 with previous version 1.0.11 dated 2023-08-08

Title: Single Cell Analysis and Differential Expression
Description: Analyzing and interactively exploring large-scale single-cell RNA-seq datasets. 'pagoda2' primarily performs normalization and differential gene expression analysis, with an interactive application for exploring single-cell RNA-seq datasets. It performs basic tasks such as cell size normalization, gene variance normalization, and can be used to identify subpopulations and run differential expression within individual samples. 'pagoda2' was written to rapidly process modern large-scale scRNAseq datasets of approximately 1e6 cells. The companion web application allows users to explore which gene expression patterns form the different subpopulations within your data. The package also serves as the primary method for preprocessing data for conos, <https://github.com/kharchenkolab/conos>. This package interacts with data available through the 'p2data' package, which is available in a 'drat' repository. To access this data package, see the instructions at <https://github.com/kharche [...truncated...]
Author: Nikolas Barkas [aut], Viktor Petukhov [aut], Peter Kharchenko [aut], Simon Steiger [ctb], Rasmus Rydbirk [ctb], Evan Biederstedt [cre, aut]
Maintainer: Evan Biederstedt <evan.biederstedt@gmail.com>

Diff between pagoda2 versions 1.0.11 dated 2023-08-08 and 1.0.12 dated 2024-02-26

 DESCRIPTION      |    6 +++---
 MD5              |   12 ++++++------
 R/Pagoda2.R      |    2 +-
 R/helpers.R      |    2 +-
 README.md        |    8 ++++----
 src/Makevars     |    2 +-
 src/Makevars.win |    2 +-
 7 files changed, 17 insertions(+), 17 deletions(-)

More information about pagoda2 at CRAN
Permanent link

Package MADPop updated to version 1.1.7 with previous version 1.1.6 dated 2023-10-13

Title: MHC Allele-Based Differencing Between Populations
Description: Tools for the analysis of population differences using the Major Histocompatibility Complex (MHC) genotypes of samples having a variable number of alleles (1-4) recorded for each individual. A hierarchical Dirichlet-Multinomial model on the genotype counts is used to pool small samples from multiple populations for pairwise tests of equality. Bayesian inference is implemented via the 'rstan' package. Bootstrapped and posterior p-values are provided for chi-squared and likelihood ratio tests of equal genotype probabilities.
Author: Martin Lysy [cre, aut], Peter W.J. Kim [aut], Terin Robinson [ctb]
Maintainer: Martin Lysy <mlysy@uwaterloo.ca>

Diff between MADPop versions 1.1.6 dated 2023-10-13 and 1.1.7 dated 2024-02-26

 DESCRIPTION                            |    8 
 MD5                                    |    8 
 inst/doc/MADPop-quicktut.html          |   26 
 inst/stan/DirichletMultinomial.stan    |   55 +
 src/stanExports_DirichletMultinomial.h | 1015 ++++++++++++++-------------------
 5 files changed, 503 insertions(+), 609 deletions(-)

More information about MADPop at CRAN
Permanent link

Package pmartR updated to version 2.4.3 with previous version 2.4.2 dated 2023-12-12

Title: Panomics Marketplace - Quality Control and Statistical Analysis for Panomics Data
Description: Provides functionality for quality control processing and statistical analysis of mass spectrometry (MS) omics data, in particular proteomic (either at the peptide or the protein level), lipidomic, and metabolomic data, as well as RNA-seq based count data and nuclear magnetic resonance (NMR) data. This includes data transformation, specification of groups that are to be compared against each other, filtering of features and/or samples, data normalization, data summarization (correlation, PCA), and statistical comparisons between defined groups. Implements methods described in: Webb-Robertson et al. (2014) <doi:10.1074/mcp.M113.030932>. Webb-Robertson et al. (2011) <doi:10.1002/pmic.201100078>. Matzke et al. (2011) <doi:10.1093/bioinformatics/btr479>. Matzke et al. (2013) <doi:10.1002/pmic.201200269>. Polpitiya et al. (2008) <doi:10.1093/bioinformatics/btn217>. Webb-Robertson et al. (2010) <doi:10.1021/pr1005247>.
Author: Lisa Bramer [aut, cre], Kelly Stratton [aut], Daniel Claborne [aut], Evan Glasscock [ctb], Rachel Richardson [ctb], David Degnan [ctb], Evan Martin [ctb]
Maintainer: Lisa Bramer <lisa.bramer@pnnl.gov>

Diff between pmartR versions 2.4.2 dated 2023-12-12 and 2.4.3 dated 2024-02-26

 DESCRIPTION                                 |   21 -
 MD5                                         |   65 ++--
 NAMESPACE                                   |    4 
 R/applyFilt.R                               |   16 -
 R/as.trelliData.R                           |  447 ++++++++++++++++++++--------
 R/edata_replace.R                           |   64 +++-
 R/filter_objects.R                          |   22 -
 R/plot_fns.R                                |  168 +++++-----
 R/pmartR.R                                  |    2 
 R/summary_trelliData.R                      |   15 
 R/trelliPlots.R                             |  325 ++++++++++++++------
 R/trelliPlots_seqData.R                     |only
 README.md                                   |   23 +
 man/as.trelliData.Rd                        |   24 +
 man/as.trelliData.edata.Rd                  |   34 +-
 man/edata_replace.Rd                        |    5 
 man/trelli_abundance_boxplot.Rd             |    5 
 man/trelli_abundance_heatmap.Rd             |    2 
 man/trelli_abundance_histogram.Rd           |    2 
 man/trelli_foldchange_bar.Rd                |    6 
 man/trelli_foldchange_boxplot.Rd            |   22 +
 man/trelli_foldchange_heatmap.Rd            |   10 
 man/trelli_foldchange_volcano.Rd            |    2 
 man/trelli_missingness_bar.Rd               |    5 
 man/trelli_precheck.Rd                      |   11 
 man/trelli_pvalue_filter.Rd                 |   35 ++
 man/trelli_rnaseq_boxplot.Rd                |only
 man/trelli_rnaseq_heatmap.Rd                |only
 man/trelli_rnaseq_histogram.Rd              |only
 man/trelli_rnaseq_nonzero_bar.Rd            |only
 tests/testthat/test_as_trelliData.R         |   48 +++
 tests/testthat/test_as_trelliData_edata.R   |   40 ++
 tests/testthat/test_as_trelliData_summary.R |   30 +
 tests/testthat/test_edata_replace.R         |  136 ++++++++
 tests/testthat/test_trelliPlots.R           |  234 +++++++++++++-
 tests/testthat/test_trelliPlots_seqData.R   |only
 tests/testthat/test_trelli_pvalue_filter.R  |only
 37 files changed, 1418 insertions(+), 405 deletions(-)

More information about pmartR at CRAN
Permanent link

Package ontologyIndex updated to version 2.12 with previous version 2.11 dated 2023-05-30

Title: Reading Ontologies into R
Description: Functions for reading ontologies into R as lists and manipulating sets of ontological terms - 'ontologyX: A suite of R packages for working with ontological data', Greene et al 2017 <doi:10.1093/bioinformatics/btw763>.
Author: Daniel Greene <dg333@cam.ac.uk>
Maintainer: Daniel Greene <dg333@cam.ac.uk>

Diff between ontologyIndex versions 2.11 dated 2023-05-30 and 2.12 dated 2024-02-26

 DESCRIPTION                      |   13 +++++++------
 MD5                              |   28 ++++++++++++++--------------
 R/data.R                         |   19 ++++++++-----------
 build/vignette.rds               |binary
 data/go.RData                    |binary
 data/hpo.RData                   |binary
 data/mpo.RData                   |binary
 inst/doc/intro-to-ontologyX.R    |    2 +-
 inst/doc/intro-to-ontologyX.html |   31 ++++++++++++++++++++++---------
 inst/doc/reading-ontologies.html |   17 ++++++++++++-----
 man/check.Rd                     |    2 +-
 man/go.Rd                        |    2 +-
 man/hpo.Rd                       |    2 +-
 man/mpo.Rd                       |    2 +-
 man/ontologyIndex-package.Rd     |   10 ----------
 15 files changed, 68 insertions(+), 60 deletions(-)

More information about ontologyIndex at CRAN
Permanent link

Package kim updated to version 0.5.422 with previous version 0.5.421 dated 2023-10-09

Title: A Toolkit for Behavioral Scientists
Description: A collection of functions for analyzing data typically collected or used by behavioral scientists. Examples of the functions include a function that compares groups in a factorial experimental design, a function that conducts two-way analysis of variance (ANOVA), and a function that cleans a data set generated by Qualtrics surveys. Some of the functions will require installing additional package(s). Such packages and other references are cited within the section describing the relevant functions. Many functions in this package rely heavily on these two popular R packages: Dowle et al. (2021) <https://CRAN.R-project.org/package=data.table>. Wickham et al. (2021) <https://CRAN.R-project.org/package=ggplot2>.
Author: Jin Kim [aut, cre]
Maintainer: Jin Kim <jin.kim1@northeastern.edu>

Diff between kim versions 0.5.421 dated 2023-10-09 and 0.5.422 dated 2024-02-26

 kim-0.5.421/kim/tests                                       |only
 kim-0.5.422/kim/DESCRIPTION                                 |   12 
 kim-0.5.422/kim/MD5                                         |   51 ++--
 kim-0.5.422/kim/NAMESPACE                                   |    1 
 kim-0.5.422/kim/NEWS.md                                     |    6 
 kim-0.5.422/kim/R/assign_fn_parameters_as_vars.R            |only
 kim-0.5.422/kim/R/bracket.R                                 |   26 +-
 kim-0.5.422/kim/R/cohen_d_over_n.R                          |    4 
 kim-0.5.422/kim/R/floodlight_2_by_continuous.R              |   35 ++
 kim-0.5.422/kim/R/floodlight_2_by_continuous_for_logistic.R |    6 
 kim-0.5.422/kim/R/floodlight_2_by_continuous_mlm_logistic.R |    6 
 kim-0.5.422/kim/R/floodlight_for_contrasts.R                |    6 
 kim-0.5.422/kim/R/floodlight_multi_by_continuous.R          |    6 
 kim-0.5.422/kim/R/histogram_w_outlier_bins.R                |    2 
 kim-0.5.422/kim/R/loglinear_analysis.R                      |    7 
 kim-0.5.422/kim/R/plot_group_means.R                        |  146 ++++++++----
 kim-0.5.422/kim/R/scatterplot.R                             |  144 +++++++++--
 kim-0.5.422/kim/R/spotlight_2_by_continuous.R               |   47 ++-
 kim-0.5.422/kim/R/two_way_anova.R                           |   37 ++-
 kim-0.5.422/kim/build/partial.rdb                           |binary
 kim-0.5.422/kim/inst/CITATION                               |    8 
 kim-0.5.422/kim/man/assign_fn_parameters_as_vars.Rd         |only
 kim-0.5.422/kim/man/bracket.Rd                              |    2 
 kim-0.5.422/kim/man/floodlight_2_by_continuous.Rd           |    8 
 kim-0.5.422/kim/man/plot_group_means.Rd                     |   43 +++
 kim-0.5.422/kim/man/scatterplot.Rd                          |   38 ++-
 kim-0.5.422/kim/man/spotlight_2_by_continuous.Rd            |   16 -
 kim-0.5.422/kim/man/two_way_anova.Rd                        |   37 ++-
 28 files changed, 506 insertions(+), 188 deletions(-)

More information about kim at CRAN
Permanent link

Package impactr updated to version 0.4.2 with previous version 0.4.1 dated 2022-08-08

Title: Mechanical Loading Prediction Through Accelerometer Data
Description: Functions to read, process and analyse accelerometer data related to mechanical loading variables. This package is developed and tested for use with raw accelerometer data from triaxial 'ActiGraph' <https://theactigraph.com> accelerometers.
Author: Lucas Veras [aut, cre]
Maintainer: Lucas Veras <lucasdsveras@gmail.com>

Diff between impactr versions 0.4.1 dated 2022-08-08 and 0.4.2 dated 2024-02-26

 DESCRIPTION                                    |   10 
 MD5                                            |   22 
 NEWS.md                                        |   42 -
 R/impactr_data.R                               |    4 
 README.md                                      |   24 
 build/partial.rdb                              |binary
 build/vignette.rds                             |binary
 inst/doc/impactr.R                             |    2 
 inst/doc/impactr.html                          |  850 ++++++++++++++++---------
 man/new_impactr_data.Rd                        |    2 
 man/new_impactr_peaks.Rd                       |    4 
 tests/testthat/_snaps/impactr_data_printing.md |   18 
 12 files changed, 634 insertions(+), 344 deletions(-)

More information about impactr at CRAN
Permanent link

Package datasauRus updated to version 0.1.8 with previous version 0.1.6 dated 2022-05-04

Title: Datasets from the Datasaurus Dozen
Description: The Datasaurus Dozen is a set of datasets with the same summary statistics. They retain the same summary statistics despite having radically different distributions. The datasets represent a larger and quirkier object lesson that is typically taught via Anscombe's Quartet (available in the 'datasets' package). Anscombe's Quartet contains four very different distributions with the same summary statistics and as such highlights the value of visualisation in understanding data, over and above summary statistics. As well as being an engaging variant on the Quartet, the data is generated in a novel way. The simulated annealing process used to derive datasets from the original Datasaurus is detailed in "Same Stats, Different Graphs: Generating Datasets with Varied Appearance and Identical Statistics through Simulated Annealing" <doi:10.1145/3025453.3025912>.
Author: Colin Gillespie [cre, aut], Steph Locke [aut], Alberto Cairo [dtc], Rhian Davies [aut], Justin Matejka [dtc], George Fitzmaurice [dtc], Lucy D'Agostino McGowan [aut], Richard Cotton [ctb], Tim Book [ctb], Jumping Rivers [fnd]
Maintainer: Colin Gillespie <colin@jumpingrivers.com>

Diff between datasauRus versions 0.1.6 dated 2022-05-04 and 0.1.8 dated 2024-02-26

 datasauRus-0.1.6/datasauRus/inst/extdata/BoxPlots.tsv                       |only
 datasauRus-0.1.6/datasauRus/inst/extdata/DatasaurusDozen-wide.tsv           |only
 datasauRus-0.1.6/datasauRus/inst/extdata/DatasaurusDozen.tsv                |only
 datasauRus-0.1.6/datasauRus/inst/extdata/SimpsonsParadox.tsv                |only
 datasauRus-0.1.6/datasauRus/inst/extdata/TwelveFromSlant-long.tsv           |only
 datasauRus-0.1.6/datasauRus/inst/extdata/TwelveFromSlant-wide.tsv           |only
 datasauRus-0.1.6/datasauRus/inst/extdata/TwelveFromSlant_alternate-long.tsv |only
 datasauRus-0.1.6/datasauRus/inst/extdata/TwelveFromSlant_alternate-wide.tsv |only
 datasauRus-0.1.8/datasauRus/DESCRIPTION                                     |   21 
 datasauRus-0.1.8/datasauRus/MD5                                             |   53 -
 datasauRus-0.1.8/datasauRus/NEWS.md                                         |    8 
 datasauRus-0.1.8/datasauRus/R/datasaurus-package.R                          |   36 
 datasauRus-0.1.8/datasauRus/README.md                                       |    2 
 datasauRus-0.1.8/datasauRus/data/box_plots_long.rda                         |only
 datasauRus-0.1.8/datasauRus/inst/doc/Datasaurus.Rmd                         |    2 
 datasauRus-0.1.8/datasauRus/inst/doc/Datasaurus.html                        |  398 +++++++---
 datasauRus-0.1.8/datasauRus/inst/extdata/Boxplots-Long.tsv                  |only
 datasauRus-0.1.8/datasauRus/inst/extdata/Boxplots-Wide.tsv                  |only
 datasauRus-0.1.8/datasauRus/inst/extdata/DatasaurusDozen-Long.tsv           |only
 datasauRus-0.1.8/datasauRus/inst/extdata/DatasaurusDozen-Wide.tsv           |only
 datasauRus-0.1.8/datasauRus/inst/extdata/SimpsonsParadox-Long.tsv           |only
 datasauRus-0.1.8/datasauRus/inst/extdata/TwelveFromSlant-Long.tsv           |only
 datasauRus-0.1.8/datasauRus/inst/extdata/TwelveFromSlant-Wide.tsv           |only
 datasauRus-0.1.8/datasauRus/inst/extdata/TwelveFromSlant_Alternate-Long.tsv |only
 datasauRus-0.1.8/datasauRus/inst/extdata/TwelveFromSlant_Alternate-Wide.tsv |only
 datasauRus-0.1.8/datasauRus/man/box_plots.Rd                                |    2 
 datasauRus-0.1.8/datasauRus/man/box_plots_long.Rd                           |only
 datasauRus-0.1.8/datasauRus/man/datasaurus_dozen.Rd                         |    2 
 datasauRus-0.1.8/datasauRus/man/datasaurus_dozen_wide.Rd                    |    2 
 datasauRus-0.1.8/datasauRus/man/simpsons_paradox.Rd                         |    2 
 datasauRus-0.1.8/datasauRus/man/simpsons_paradox_wide.Rd                    |    2 
 datasauRus-0.1.8/datasauRus/man/twelve_from_slant_alternate_long.Rd         |    2 
 datasauRus-0.1.8/datasauRus/man/twelve_from_slant_alternate_wide.Rd         |    2 
 datasauRus-0.1.8/datasauRus/man/twelve_from_slant_long.Rd                   |    2 
 datasauRus-0.1.8/datasauRus/man/twelve_from_slant_wide.Rd                   |    2 
 datasauRus-0.1.8/datasauRus/tests/testthat/test-rawfiles.R                  |    2 
 datasauRus-0.1.8/datasauRus/vignettes/Datasaurus.Rmd                        |    2 
 37 files changed, 395 insertions(+), 147 deletions(-)

More information about datasauRus at CRAN
Permanent link

Package rmumps updated to version 5.2.1-28 with previous version 5.2.1-27 dated 2024-02-05

Title: Wrapper for MUMPS Library
Description: Some basic features of 'MUMPS' (Multifrontal Massively Parallel sparse direct Solver) are wrapped in a class whose methods can be used for sequentially solving a sparse linear system (symmetric or not) with one or many right hand sides (dense or sparse). There is a possibility to do separately symbolic analysis, LU (or LDL^t) factorization and system solving. Third part ordering libraries are included and can be used: 'PORD', 'METIS', 'SCOTCH'. 'MUMPS' method was first described in Amestoy et al. (2001) <doi:10.1137/S0895479899358194> and Amestoy et al. (2006) <doi:10.1016/j.parco.2005.07.004>.
Author: Serguei Sokol [aut, cre], Emmanuel Agullo [ctb], Patrick Amestoy [ctb, cph], Maurice Bremond [ctb], Alfredo Buttari [ctb], Philippe Combes [ctb], Marie Durand [ctb], Aurelia Fevre [ctb], Abdou Guermouche [ctb], Guillaume Joslin [ctb], Jacko Koster [c [...truncated...]
Maintainer: Serguei Sokol <sokol@insa-toulouse.fr>

Diff between rmumps versions 5.2.1-27 dated 2024-02-05 and 5.2.1-28 dated 2024-02-26

 DESCRIPTION                               |   10 ++++++----
 MD5                                       |    8 ++++----
 NEWS                                      |    7 ++++++-
 inst/COPYRIGHTS                           |    2 +-
 src/lib/scotch_6.0.9/src/esmumps/Makefile |    1 +
 5 files changed, 18 insertions(+), 10 deletions(-)

More information about rmumps at CRAN
Permanent link

New package preventr with initial version 0.9.0
Package: preventr
Title: An Implementation of the AHA PREVENT Equations
Version: 0.9.0
Description: Implements the American Heart Association (AHA) Predicting Risk of cardiovascular disease EVENTs (PREVENT) equations from Khan SS, Matsushita K, Sang Y, and colleagues (2024) <doi:10.1161/CIRCULATIONAHA.123.067626>.
License: MIT + file LICENSE
URL: https://martingmayer.com/preventr, https://github.com/martingmayer/preventr
Encoding: UTF-8
Depends: R (>= 3.5.0)
Imports: dplyr
Suggests: testthat (>= 3.0.0)
NeedsCompilation: no
Packaged: 2024-02-25 13:49:11 UTC; MartyMayer
Author: Martin Mayer [aut, cre, cph]
Maintainer: Martin Mayer <mmayer@ebsco.com>
Repository: CRAN
Date/Publication: 2024-02-26 19:20:02 UTC

More information about preventr at CRAN
Permanent link

Package N2R updated to version 1.0.3 with previous version 1.0.2 dated 2024-02-26

Title: Fast and Scalable Approximate k-Nearest Neighbor Search Methods using 'N2' Library
Description: Implements methods to perform fast approximate K-nearest neighbor search on input matrix. Algorithm based on the 'N2' implementation of an approximate nearest neighbor search using hierarchical Navigable Small World (NSW) graphs. The original algorithm is described in "Efficient and Robust Approximate Nearest Neighbor Search Using Hierarchical Navigable Small World Graphs", Y. Malkov and D. Yashunin, <doi:10.1109/TPAMI.2018.2889473>, <arXiv:1603.09320>.
Author: Peter Kharchenko [aut], Viktor Petukhov [aut], Dirk Eddelbuettel [ctb], Evan Biederstedt [cre, aut]
Maintainer: Evan Biederstedt <evan.biederstedt@gmail.com>

Diff between N2R versions 1.0.2 dated 2024-02-26 and 1.0.3 dated 2024-02-26

 DESCRIPTION         |    6 +++---
 MD5                 |    8 ++++----
 README.md           |    2 +-
 src/n2/Makefile     |    4 ++--
 src/n2/Makefile.win |    4 ++--
 5 files changed, 12 insertions(+), 12 deletions(-)

More information about N2R at CRAN
Permanent link

Package memoiR updated to version 1.2-7 with previous version 1.2-4 dated 2023-09-14

Title: R Markdown and Bookdown Templates to Publish Documents
Description: Producing high-quality documents suitable for publication directly from R is made possible by the R Markdown ecosystem. 'memoiR' makes it easy. It provides templates to knit memoirs, articles and slideshows with helpers to publish the documents on GitHub Pages and activate continuous integration.
Author: Eric Marcon [aut, cre]
Maintainer: Eric Marcon <eric.marcon@agroparistech.fr>

Diff between memoiR versions 1.2-4 dated 2023-09-14 and 1.2-7 dated 2024-02-26

 DESCRIPTION                                                        |   11 -
 MD5                                                                |   24 +-
 NEWS.md                                                            |   17 +
 R/memoiR.R                                                         |   13 -
 README.md                                                          |   14 -
 build/vignette.rds                                                 |binary
 inst/rmarkdown/templates/beamer_presentation/skeleton/skeleton.Rmd |   33 ++-
 inst/rmarkdown/templates/memoir/skeleton/82-syntax.Rmd             |   95 +++++++---
 inst/rmarkdown/templates/memoir/skeleton/index.Rmd                 |   24 +-
 inst/rmarkdown/templates/simple_article/skeleton/skeleton.Rmd      |   86 ++++++---
 inst/rmarkdown/templates/stylish_article/skeleton/skeleton.Rmd     |   86 ++++++---
 man/memoiR-package.Rd                                              |    1 
 tests/testthat/test_build.R                                        |   39 ++--
 13 files changed, 299 insertions(+), 144 deletions(-)

More information about memoiR at CRAN
Permanent link

Package HDSinRdata updated to version 0.1.1 with previous version 0.1.0 dated 2023-08-18

Title: Data for the 'Mastering Health Data Science Using R' Online Textbook
Description: Contains nine datasets used in the chapters and exercises of Paul, Alice (2023) "Health Data Science in R" <https://alicepaul.github.io/health-data-science-using-r/>.
Author: Alice Paul [aut, cre], Hannah Englinton [aut], Jialin Liu [ctb], Joanna Walsh [aut], Xinbei Yu [ctb]
Maintainer: Alice Paul <alice_paul@brown.edu>

Diff between HDSinRdata versions 0.1.0 dated 2023-08-18 and 0.1.1 dated 2024-02-26

 DESCRIPTION               |   26 ++++++++++++++++----------
 MD5                       |   23 ++++++++++++++---------
 NEWS.md                   |only
 R/covidcases.R            |    2 +-
 R/lockdowndates.R         |   10 +++++++---
 R/tb_diagnosis.R          |only
 build                     |only
 data/covidcases.rda       |binary
 data/lockdowndates.rda    |binary
 data/tb_diagnosis.rda     |only
 man/HDSinRdata-package.Rd |    8 ++++----
 man/covidcases.Rd         |    2 +-
 man/lockdowndates.Rd      |   10 +++++++---
 man/mobility.Rd           |    2 +-
 man/tb_diagnosis.Rd       |only
 15 files changed, 51 insertions(+), 32 deletions(-)

More information about HDSinRdata at CRAN
Permanent link

New package growthcleanr with initial version 2.2.0
Package: growthcleanr
Title: Data Cleaner for Anthropometric Measurements
Version: 2.2.0
Description: Identifies implausible anthropometric (e.g., height, weight) measurements in irregularly spaced longitudinal datasets, such as those from electronic health records.
URL: https://carriedaymont.github.io/growthcleanr/index.html, https://github.com/carriedaymont/growthcleanr
BugReports: https://github.com/carriedaymont/growthcleanr/issues
Imports: R.utils (>= 2.11.0), data.table (>= 1.13.0), tidyr (>= 1.1.0), plyr (>= 1.8.6), dplyr (>= 1.0.1), foreach (>= 1.5.0), doParallel (>= 1.0.15), labelled (>= 2.5.0), magrittr (>= 1.5)
Depends: R (>= 2.10)
License: MIT + file LICENSE
Encoding: UTF-8
LazyData: true
Suggests: argparser (>= 0.6), bit64 (>= 4.0.2), knitr (>= 1.29), rmarkdown (>= 2.3), testthat (>= 2.3.2)
NeedsCompilation: no
Packaged: 2024-02-22 21:16:30 UTC; HDELOSSANTOS
Author: Carrie Daymont [ctb, cre], Robert Grundmeier [aut], Jeffrey Miller [aut], Diego Campos [aut], Dan Chudnov [ctb], Hannah De los Santos [ctb], Lusha Cao [ctb], Steffani Silva [ctb], Hanzhe Zhang [ctb], Matt Boyas [ctb], David Freedman [ctb], Andreas Ac [...truncated...]
Maintainer: Carrie Daymont <cdaymont@pennstatehealth.psu.edu>
Repository: CRAN
Date/Publication: 2024-02-26 19:30:02 UTC

More information about growthcleanr at CRAN
Permanent link

Package conos updated to version 1.5.2 with previous version 1.5.1 dated 2024-01-23

Title: Clustering on Network of Samples
Description: Wires together large collections of single-cell RNA-seq datasets, which allows for both the identification of recurrent cell clusters and the propagation of information between datasets in multi-sample or atlas-scale collections. 'Conos' focuses on the uniform mapping of homologous cell types across heterogeneous sample collections. For instance, users could investigate a collection of dozens of peripheral blood samples from cancer patients combined with dozens of controls, which perhaps includes samples of a related tissue such as lymph nodes. This package interacts with data available through the 'conosPanel' package, which is available in a 'drat' repository. To access this data package, see the instructions at <https://github.com/kharchenkolab/conos>. The size of the 'conosPanel' package is approximately 12 MB.
Author: Viktor Petukhov [aut], Nikolas Barkas [aut], Peter Kharchenko [aut], Weiliang Qiu [ctb], Evan Biederstedt [aut, cre]
Maintainer: Evan Biederstedt <evan.biederstedt@gmail.com>

Diff between conos versions 1.5.1 dated 2024-01-23 and 1.5.2 dated 2024-02-26

 DESCRIPTION      |    6 +++---
 MD5              |    8 ++++----
 README.md        |    2 +-
 src/Makevars     |    2 +-
 src/Makevars.win |    2 +-
 5 files changed, 10 insertions(+), 10 deletions(-)

More information about conos at CRAN
Permanent link

Package Colossus updated to version 1.0.1 with previous version 1.0.0 dated 2024-02-20

Title: "Risk Model Regression and Analysis with Complex Non-Linear Models"
Description: Performs survival analysis using general non-linear models. Risk models can be the sum or product of terms. Each term is the product of exponential/linear functions of covariates. Additionally sub-terms can be defined as a sum of exponential, linear threshold, and step functions. Cox Proportional hazards <https://en.wikipedia.org/wiki/Proportional_hazards_model>, Poisson <https://en.wikipedia.org/wiki/Poisson_regression>, and Fine-Grey competing risks <https://www.publichealth.columbia.edu/research/population-health-methods/competing-risk-analysis> regression are supported. This work was sponsored by NASA Grant 80NSSC19M0161 through a subcontract from the National Council on Radiation Protection and Measurements (NCRP). The computing for this project was performed on the Beocat Research Cluster at Kansas State University, which is funded in part by NSF grants CNS-1006860, EPS-1006860, EPS-0919443, ACI-1440548, CHE-1726332, and NIH P20GM113109.
Author: Eric Giunta [aut, cre] , Amir Bahadori [ctb] , Dan Andresen [ctb], Linda Walsh [ctb] , Benjamin French [ctb] , Lawrence Dauer [ctb], John Boice Jr [ctb] , Kansas State University [cph], NASA [fnd], NCRP [fnd], NRC [fnd]
Maintainer: Eric Giunta <egiunta@ksu.edu>

Diff between Colossus versions 1.0.0 dated 2024-02-20 and 1.0.1 dated 2024-02-26

 DESCRIPTION                        |    9 ++-
 MD5                                |   14 ++---
 NEWS.md                            |   23 ++-------
 README.md                          |    7 ++
 build/vignette.rds                 |binary
 inst/doc/starting-description.html |    2 
 src/Main_Functions.cpp             |    4 -
 tools/config/configure.R           |   89 ++++++++++++++++++++++++++++++++++---
 8 files changed, 110 insertions(+), 38 deletions(-)

More information about Colossus at CRAN
Permanent link

New package connectoModa with initial version 1.0.0
Package: connectoModa
Title: Download Data from Moda
Version: 1.0.0
Description: Connect to WFP's Moda platform to R, download data, and obtain the list of individuals with access to the project along with their access level.
License: MIT + file LICENSE
Encoding: UTF-8
Imports: httr, jsonlite, readr
NeedsCompilation: no
Packaged: 2024-02-24 16:43:33 UTC; USER MSI
Author: Idrissa DABO [aut, cre]
Maintainer: Idrissa DABO <ididabo@gmail.com>
Repository: CRAN
Date/Publication: 2024-02-26 19:10:02 UTC

More information about connectoModa at CRAN
Permanent link

New package camtrapR with initial version 2.3.0
Package: camtrapR
Title: Camera Trap Data Management and Preparation of Occupancy and Spatial Capture-Recapture Analyses
Version: 2.3.0
Date: 2024-02-24
Depends: R (>= 3.1.0)
Imports: data.table, generics, ggplot2, lubridate, methods, secr, sf
Suggests: abind, coda, DT, knitr, lattice, leaflet, magick, mapview, nimble, nimbleEcology, overlap, parallel, plotly, reshape2, rjags, R.rsp, RSQLite, ritis, rmarkdown, shiny, shinydashboard, tesseract, taxize, terra, testthat, tibble, units, unmarked, zip
VignetteBuilder: R.rsp
SystemRequirements: ExifTool (https://exiftool.org/)
Description: Management of and data extraction from camera trap data in wildlife studies. The package provides a workflow for storing and sorting camera trap photos (and videos), tabulates records of species and individuals, and creates detection/non-detection matrices for occupancy and spatial capture-recapture analyses with great flexibility. In addition, it can visualise species activity data and provides simple mapping functions with GIS export.
URL: https://github.com/jniedballa/camtrapR, https://jniedballa.github.io/camtrapR/, https://groups.google.com/forum/#!forum/camtrapr
BugReports: https://groups.google.com/forum/#!forum/camtrapr
Encoding: UTF-8
License: GPL (>= 2)
NeedsCompilation: no
Packaged: 2024-02-25 18:00:47 UTC; niedballa
Author: Juergen Niedballa [aut, cre] , Alexandre Courtiol [aut] , Rahel Sollmann [aut] , John Mathai [ctb], Seth Timothy Wong [ctb] , An The Truong Nguyen [ctb] , Azlan bin Mohamed [ctb] , Andrew Tilker [ctb] , Roshan Guharajan [ctb] , Ioannis Alexiou [ctb] [...truncated...]
Maintainer: Juergen Niedballa <camtrapr@gmail.com>
Repository: CRAN
Date/Publication: 2024-02-26 19:40:02 UTC

More information about camtrapR at CRAN
Permanent link

Package bayesdfa updated to version 1.3.3 with previous version 1.3.2 dated 2024-01-12

Title: Bayesian Dynamic Factor Analysis (DFA) with 'Stan'
Description: Implements Bayesian dynamic factor analysis with 'Stan'. Dynamic factor analysis is a dimension reduction tool for multivariate time series. 'bayesdfa' extends conventional dynamic factor models in several ways. First, extreme events may be estimated in the latent trend by modeling process error with a student-t distribution. Second, alternative constraints (including proportions are allowed). Third, the estimated dynamic factors can be analyzed with hidden Markov models to evaluate support for latent regimes.
Author: Eric J. Ward [aut, cre], Sean C. Anderson [aut], Luis A. Damiano [aut], Michael J. Malick [aut], Mary E. Hunsicker, [ctb], Mike A. Litzow [ctb], Mark D. Scheuerell [ctb], Elizabeth E. Holmes [ctb], Nick Tolimieri [ctb], Trustees of Columbia Universit [...truncated...]
Maintainer: Eric J. Ward <eric.ward@noaa.gov>

Diff between bayesdfa versions 1.3.2 dated 2024-01-12 and 1.3.3 dated 2024-02-26

 DESCRIPTION                             |   10 
 MD5                                     |   31 
 NEWS.md                                 |    4 
 R/find_regimes.R                        |   10 
 inst/doc/a1_bayesdfa.html               |  282 
 inst/doc/a2_combining_data.html         |    4 
 inst/doc/a3_covariates.html             |    4 
 inst/doc/a4_smooth.html                 |    4 
 inst/doc/a5_estimate_process_sigma.html |    4 
 inst/doc/a6_compositional.html          |    6 
 inst/doc/a7_bigdata.html                |    4 
 man/bayesdfa-package.Rd                 |   29 
 src/stanExports_corr.h                  |  647 +-
 src/stanExports_dfa.h                   | 9523 +++++++++++++++-----------------
 src/stanExports_hmm_gaussian.h          | 2126 +++----
 src/stanExports_regime_1.h              |  775 +-
 tests/testthat/Rplots.pdf               |only
 17 files changed, 6562 insertions(+), 6901 deletions(-)

More information about bayesdfa at CRAN
Permanent link

New package raybevel with initial version 0.1.1
Package: raybevel
Title: Generates Polygon Straight Skeletons and 3D Bevels
Version: 0.1.1
Maintainer: Tyler Morgan-Wall <tylermw@gmail.com>
Description: Generates polygon straight skeletons and 3D models. Provides functions to create and visualize interior polygon offsets, 3D beveled polygons, and 3D roof models.
License: GPL-3
Encoding: UTF-8
Depends: R (>= 3.0.2)
Imports: progress, digest, decido, rayvertex (>= 0.10.4), sf, grid
LinkingTo: Rcpp, BH, RcppCGAL, progress, RcppThread (>= 2.1.6)
Suggests: spData, rayrender, testthat (>= 3.0.0), ggplot2, png
URL: https://www.raybevel.com, https://github.com/tylermorganwall/raybevel/
BugReports: https://github.com/tylermorganwall/raybevel/issues
NeedsCompilation: yes
Packaged: 2024-02-23 17:53:11 UTC; tyler
Author: Tyler Morgan-Wall [aut, cph, cre]
Repository: CRAN
Date/Publication: 2024-02-26 19:00:02 UTC

More information about raybevel at CRAN
Permanent link

Package crandep updated to version 0.3.6 with previous version 0.3.5 dated 2024-01-19

Title: Network Analysis of Dependencies of CRAN Packages
Description: The dependencies of CRAN packages can be analysed in a network fashion. For each package we can obtain the packages that it depends, imports, suggests, etc. By iterating this procedure over a number of packages, we can build, visualise, and analyse the dependency network, enabling us to have a bird's-eye view of the CRAN ecosystem. One aspect of interest is the number of reverse dependencies of the packages, or equivalently the in-degree distribution of the dependency network. This can be fitted by the power law and/or an extreme value mixture distribution <arXiv:2008.03073>, of which functions are provided.
Author: Clement Lee [aut, cre]
Maintainer: Clement Lee <clement.lee.tm@outlook.com>

Diff between crandep versions 0.3.5 dated 2024-01-19 and 0.3.6 dated 2024-02-26

 DESCRIPTION                |    8 +-
 MD5                        |   28 ++++----
 NAMESPACE                  |    4 +
 NEWS.md                    |   11 +++
 R/RcppExports.R            |    4 -
 R/optim.R                  |   58 ++++++++++++++++++
 inst/doc/cran.html         |   64 ++++++++++----------
 inst/doc/degree.R          |   13 ++++
 inst/doc/degree.Rmd        |   18 +++++
 inst/doc/degree.html       |  131 ++++++++++++++++++++++-------------------
 inst/doc/introduction.html |    6 -
 man/lpost_pow.Rd           |only
 man/marg_pow.Rd            |only
 src/RcppExports.cpp        |   10 +--
 src/algo.cpp               |  143 +++++++++++++++++++++++++--------------------
 vignettes/degree.Rmd       |   18 +++++
 16 files changed, 333 insertions(+), 183 deletions(-)

More information about crandep at CRAN
Permanent link

New package clusEvol with initial version 1.0.0
Package: clusEvol
Title: A Procedure for Cluster Evolution Analytics
Version: 1.0.0
Date: 2024-02-19
Maintainer: Victor Morales-Onate <victor.morales@uv.cl>
Description: Cluster Evolution Analytics allows us to use exploratory what if questions in the sense that the present information of an object is plugged-in a dataset in a previous time frame so that we can explore its evolution (and of its neighbors) to the present. See the URL for the papers associated with this package, as for instance, Morales-Oñate and Morales-Oñate (2024) <https://mpra.ub.uni-muenchen.de/120220>.
Depends: R (>= 4.1.0)
License: GPL (>= 3)
Encoding: UTF-8
Imports: ggplot2,plotly,cluster,fpc,viridis,clusterSim,dplyr
Repository: CRAN
URL: https://github.com/vmoprojs/clusEvol
BugReports: https://github.com/vmoprojs/clusEvol/issues
LazyData: true
NeedsCompilation: no
Packaged: 2024-02-23 23:27:37 UTC; victormorales
Author: Victor Morales-Onate [aut, cre] , Bolivar Morales-Onate [aut]
Date/Publication: 2024-02-26 18:50:02 UTC

More information about clusEvol at CRAN
Permanent link

New package CFO with initial version 1.0.0
Package: CFO
Title: CFO-Type Designs in Phase I Clinical Trials
Version: 1.0.0
Imports: survival,dplyr,ggplot2,Iso
Description: In phase I clinical trials, the primary objective is to ascertain the maximum tolerated dose (MTD) corresponding to a specified target toxicity rate. The 'CFO' package facilitates the implementation of dose-finding trials by utilizing calibration-free odds type (CFO-type) designs. Specifically, it encompasses the calibration-free odds (CFO) (Jin and Yin (2022) <doi:10.1177/09622802221079353>), two-dimensional CFO (2dCFO) (Wang et al. (2023) <doi:10.3389/fonc.2023.1294258>), time-to-event CFO (TITE-CFO) (Jin and Yin (2023) <doi:10.1002/pst.2304>), fractional CFO (fCFO), accumulative CFO (aCFO), TITE-aCFO, and f-aCFO designs. The ‘CFO' package accommodates diverse CFO-type designs, allowing users to tailor the approach based on factors such as dose information inclusion, handling of late-onset toxicity, and the nature of the target drug (single-drug or drug-combination). The functionalities embedded in 'CFO' package include the determination of the dose level for the ne [...truncated...]
License: GPL-2
Encoding: UTF-8
NeedsCompilation: no
Packaged: 2024-02-24 08:57:57 UTC; nikkifang
Author: Jialu Fang [aut, cre], Wenliang Wang [aut], Guosheng Yin [aut]
Maintainer: Jialu Fang <u3008682@connect.hku.hk>
Repository: CRAN
Date/Publication: 2024-02-26 19:00:08 UTC

More information about CFO at CRAN
Permanent link

New package bigrquerystorage with initial version 1.0.0
Package: bigrquerystorage
Title: An Interface to Google's 'BigQuery Storage' API
Version: 1.0.0
Maintainer: Bruno Tremblay <openr@neoxone.com>
Description: Easily talk to Google's 'BigQuery Storage' API from R (<https://cloud.google.com/bigquery/docs/reference/storage/rpc>).
License: Apache License (>= 2)
Imports: arrow, methods, rlang, DBI, bigrquery, assertthat, Rcpp, lifecycle, bit64, tibble
Suggests: testthat, hms, wk, tzdb, base64enc
LinkingTo: Rcpp
Encoding: UTF-8
URL: https://github.com/meztez/bigrquerystorage
BugReports: https://github.com/meztez/bigrquerystorage/issues
SystemRequirements: grpc/protobuf headers and compilers. For example libprotobuf-dev libgrpc++-dev protobuf-compiler-grpc (Debian) or protobuf-devel grpc-devel grpc-plugins (Fedora/RHEL)
Biarch: TRUE
NeedsCompilation: yes
Packaged: 2024-02-24 01:11:06 UTC; bruno
Author: Bruno Tremblay [aut, cre], Google LLC [cph, fnd]
Repository: CRAN
Date/Publication: 2024-02-26 19:00:05 UTC

More information about bigrquerystorage at CRAN
Permanent link

Package Pandora updated to version 24.2.0 with previous version 23.12.0 dated 2023-12-19

Title: Retrieve Data using the API of the 'Pandora' Data Platform
Description: API wrapper that contains functions to retrieve data from the 'Pandora' databases. Web services for API: <https://pandora.earth/>.
Author: Jan Abel [cre], Antonia Runge [aut], Andreas Neudecker [aut], Ricardo Fernandes [aut]
Maintainer: Jan Abel <jan.abel@inwt-statistics.de>

Diff between Pandora versions 23.12.0 dated 2023-12-19 and 24.2.0 dated 2024-02-26

 DESCRIPTION                           |   11 -
 MD5                                   |   13 -
 NEWS.md                               |    6 
 inst/doc/how-to-use-pandora-data.Rmd  |    1 
 inst/doc/how-to-use-pandora-data.html |  339 ++++++++++++++++------------------
 tests/testthat/helpers.R              |only
 tests/testthat/test-getData.R         |  141 ++++++++------
 vignettes/how-to-use-pandora-data.Rmd |    1 
 8 files changed, 269 insertions(+), 243 deletions(-)

More information about Pandora at CRAN
Permanent link

Package nexus updated to version 0.2.0 with previous version 0.1.0 dated 2023-11-29

Title: Sourcing Archaeological Materials by Chemical Composition
Description: Exploration and analysis of compositional data in the framework of Aitchison (1986, ISBN: 978-94-010-8324-9). This package provides tools for chemical fingerprinting and source tracking of ancient materials.
Author: Nicolas Frerebeau [aut, cre] , Anne Philippe [aut] , Brice Lebrun [ctb] , Arthur Leck [ctb] , Universite Bordeaux Montaigne [fnd], CNRS [fnd]
Maintainer: Nicolas Frerebeau <nicolas.frerebeau@u-bordeaux-montaigne.fr>

Diff between nexus versions 0.1.0 dated 2023-11-29 and 0.2.0 dated 2024-02-26

 nexus-0.1.0/nexus/inst/doc/bibliography.R                               |only
 nexus-0.1.0/nexus/inst/doc/bibliography.Rmd                             |only
 nexus-0.1.0/nexus/inst/doc/bibliography.html                            |only
 nexus-0.1.0/nexus/man/policy.Rd                                         |only
 nexus-0.1.0/nexus/vignettes/bibliography.Rmd                            |only
 nexus-0.2.0/nexus/DESCRIPTION                                           |   26 
 nexus-0.2.0/nexus/MD5                                                   |  141 -
 nexus-0.2.0/nexus/NAMESPACE                                             |   21 
 nexus-0.2.0/nexus/NEWS.md                                               |   13 
 nexus-0.2.0/nexus/R/AllClasses.R                                        |   14 
 nexus-0.2.0/nexus/R/AllGenerics.R                                       |  114 -
 nexus-0.2.0/nexus/R/coerce.R                                            |   14 
 nexus-0.2.0/nexus/R/graph.R                                             |    6 
 nexus-0.2.0/nexus/R/mix.R                                               |    2 
 nexus-0.2.0/nexus/R/mutators.R                                          |   12 
 nexus-0.2.0/nexus/R/nexus-package.R                                     |    5 
 nexus-0.2.0/nexus/R/outliers.R                                          |   42 
 nexus-0.2.0/nexus/R/plot.R                                              |  138 +
 nexus-0.2.0/nexus/R/reexport.R                                          |   16 
 nexus-0.2.0/nexus/R/statistics.R                                        |   88 
 nexus-0.2.0/nexus/R/subset.R                                            |   19 
 nexus-0.2.0/nexus/R/transform.R                                         |   50 
 nexus-0.2.0/nexus/README.md                                             |   29 
 nexus-0.2.0/nexus/build/vignette.rds                                    |binary
 nexus-0.2.0/nexus/inst/CITATION                                         |    5 
 nexus-0.2.0/nexus/inst/doc/nexus.R                                      |    4 
 nexus-0.2.0/nexus/inst/doc/nexus.Rmd                                    |   30 
 nexus-0.2.0/nexus/inst/doc/nexus.html                                   | 1060 +++-------
 nexus-0.2.0/nexus/inst/examples/ex-aggregate.R                          |    6 
 nexus-0.2.0/nexus/inst/examples/ex-barplot.R                            |    4 
 nexus-0.2.0/nexus/inst/examples/ex-graph.R                              |    4 
 nexus-0.2.0/nexus/inst/examples/ex-hist.R                               |only
 nexus-0.2.0/nexus/inst/examples/ex-mean.R                               |    3 
 nexus-0.2.0/nexus/inst/examples/ex-pca.R                                |    3 
 nexus-0.2.0/nexus/inst/examples/ex-split.R                              |only
 nexus-0.2.0/nexus/inst/tinytest/_snaps/ilr_base_classic.rds             |only
 nexus-0.2.0/nexus/inst/tinytest/_snaps/outliers.rds                     |binary
 nexus-0.2.0/nexus/inst/tinytest/_snaps/quantile.rds                     |only
 nexus-0.2.0/nexus/inst/tinytest/_tinysnapshot/plot_barplot.svg          |   10 
 nexus-0.2.0/nexus/inst/tinytest/_tinysnapshot/plot_barplot_group.svg    |  262 +-
 nexus-0.2.0/nexus/inst/tinytest/_tinysnapshot/plot_barplot_order.svg    |   10 
 nexus-0.2.0/nexus/inst/tinytest/_tinysnapshot/plot_barplot_vertical.svg |   10 
 nexus-0.2.0/nexus/inst/tinytest/_tinysnapshot/plot_hist.svg             |only
 nexus-0.2.0/nexus/inst/tinytest/test_plot.R                             |    6 
 nexus-0.2.0/nexus/inst/tinytest/test_statistics.R                       |   11 
 nexus-0.2.0/nexus/inst/tinytest/test_transform.R                        |    3 
 nexus-0.2.0/nexus/man/CompositionMatrix-class.Rd                        |    8 
 nexus-0.2.0/nexus/man/OutlierIndex-class.Rd                             |   10 
 nexus-0.2.0/nexus/man/aggregate.Rd                                      |   19 
 nexus-0.2.0/nexus/man/as_graph.Rd                                       |    5 
 nexus-0.2.0/nexus/man/barplot.Rd                                        |   15 
 nexus-0.2.0/nexus/man/covariance.Rd                                     |    1 
 nexus-0.2.0/nexus/man/dist.Rd                                           |    1 
 nexus-0.2.0/nexus/man/figures/README-groups-1.png                       |only
 nexus-0.2.0/nexus/man/groups.Rd                                         |    1 
 nexus-0.2.0/nexus/man/hist.Rd                                           |only
 nexus-0.2.0/nexus/man/identifiers.Rd                                    |    1 
 nexus-0.2.0/nexus/man/mahalanobis.Rd                                    |    1 
 nexus-0.2.0/nexus/man/margin.Rd                                         |    1 
 nexus-0.2.0/nexus/man/mean.Rd                                           |    4 
 nexus-0.2.0/nexus/man/metric_var.Rd                                     |    4 
 nexus-0.2.0/nexus/man/missing.Rd                                        |only
 nexus-0.2.0/nexus/man/nexus-package.Rd                                  |    5 
 nexus-0.2.0/nexus/man/pca.Rd                                            |    3 
 nexus-0.2.0/nexus/man/plot.Rd                                           |    1 
 nexus-0.2.0/nexus/man/plot_logratio.Rd                                  |    1 
 nexus-0.2.0/nexus/man/quantile.Rd                                       |only
 nexus-0.2.0/nexus/man/reexports.Rd                                      |    9 
 nexus-0.2.0/nexus/man/replace_NA.Rd                                     |    8 
 nexus-0.2.0/nexus/man/replace_zero.Rd                                   |    6 
 nexus-0.2.0/nexus/man/samples.Rd                                        |    1 
 nexus-0.2.0/nexus/man/scale.Rd                                          |    1 
 nexus-0.2.0/nexus/man/split.Rd                                          |only
 nexus-0.2.0/nexus/man/subset.Rd                                         |   12 
 nexus-0.2.0/nexus/man/totals.Rd                                         |    1 
 nexus-0.2.0/nexus/man/transform_ilr.Rd                                  |   11 
 nexus-0.2.0/nexus/man/variation.Rd                                      |    1 
 nexus-0.2.0/nexus/vignettes/bibliography.bib                            |   73 
 nexus-0.2.0/nexus/vignettes/nexus.Rmd                                   |   30 
 79 files changed, 1311 insertions(+), 1104 deletions(-)

More information about nexus at CRAN
Permanent link

Package N2R updated to version 1.0.2 with previous version 1.0.1 dated 2022-01-18

Title: Fast and Scalable Approximate k-Nearest Neighbor Search Methods using 'N2' Library
Description: Implements methods to perform fast approximate K-nearest neighbor search on input matrix. Algorithm based on the 'N2' implementation of an approximate nearest neighbor search using hierarchical Navigable Small World (NSW) graphs. The original algorithm is described in "Efficient and Robust Approximate Nearest Neighbor Search Using Hierarchical Navigable Small World Graphs", Y. Malkov and D. Yashunin, <doi:10.1109/TPAMI.2018.2889473>, <arXiv:1603.09320>.
Author: Peter Kharchenko [aut], Viktor Petukhov [aut], Dirk Eddelbuettel [ctb], Evan Biederstedt [cre, aut]
Maintainer: Evan Biederstedt <evan.biederstedt@gmail.com>

Diff between N2R versions 1.0.1 dated 2022-01-18 and 1.0.2 dated 2024-02-26

 DESCRIPTION         |    7 +++----
 MD5                 |   12 ++++++------
 README.md           |    2 +-
 src/Makevars        |    3 +--
 src/Makevars.win    |    3 +--
 src/n2/Makefile     |    8 ++++----
 src/n2/Makefile.win |    9 ++++-----
 7 files changed, 20 insertions(+), 24 deletions(-)

More information about N2R at CRAN
Permanent link

Package kairos updated to version 2.1.0 with previous version 2.0.2 dated 2023-11-27

Title: Analysis of Chronological Patterns from Archaeological Count Data
Description: A toolkit for absolute and relative dating and analysis of chronological patterns. This package includes functions for chronological modeling and dating of archaeological assemblages from count data. It provides methods for matrix seriation. It also allows to compute time point estimates and density estimates of the occupation and duration of an archaeological site.
Author: Nicolas Frerebeau [aut, cre] , Brice Lebrun [ctb] , Ben Marwick [ctb] , Anne Philippe [ctb] , Universite Bordeaux Montaigne [fnd], CNRS [fnd]
Maintainer: Nicolas Frerebeau <nicolas.frerebeau@u-bordeaux-montaigne.fr>

Diff between kairos versions 2.0.2 dated 2023-11-27 and 2.1.0 dated 2024-02-26

 kairos-2.0.2/kairos/inst/doc/bibliography.R           |only
 kairos-2.0.2/kairos/inst/doc/bibliography.Rmd         |only
 kairos-2.0.2/kairos/inst/doc/bibliography.html        |only
 kairos-2.0.2/kairos/vignettes/bibliography.Rmd        |only
 kairos-2.1.0/kairos/DESCRIPTION                       |   18 
 kairos-2.1.0/kairos/MD5                               |   50 
 kairos-2.1.0/kairos/NAMESPACE                         |   19 
 kairos-2.1.0/kairos/NEWS.md                           |    7 
 kairos-2.1.0/kairos/R/AllClasses.R                    |   10 
 kairos-2.1.0/kairos/R/AllGenerics.R                   |   12 
 kairos-2.1.0/kairos/R/kairos-package.R                |    6 
 kairos-2.1.0/kairos/R/reexport.R                      |   12 
 kairos-2.1.0/kairos/R/seriate_refine.R                |   30 
 kairos-2.1.0/kairos/README.md                         |   24 
 kairos-2.1.0/kairos/build/vignette.rds                |binary
 kairos-2.1.0/kairos/inst/CITATION                     |    3 
 kairos-2.1.0/kairos/inst/doc/event.Rmd                |   35 
 kairos-2.1.0/kairos/inst/doc/event.html               | 1034 +++++-------------
 kairos-2.1.0/kairos/inst/doc/seriation.R              |   20 
 kairos-2.1.0/kairos/inst/doc/seriation.Rmd            |   49 
 kairos-2.1.0/kairos/inst/doc/seriation.html           |  886 +++++----------
 kairos-2.1.0/kairos/man/figures/README-aoristic-2.png |binary
 kairos-2.1.0/kairos/man/kairos-package.Rd             |    5 
 kairos-2.1.0/kairos/man/reexports.Rd                  |    5 
 kairos-2.1.0/kairos/man/seriate_refine.Rd             |   17 
 kairos-2.1.0/kairos/vignettes/bibliography.bib        |  128 +-
 kairos-2.1.0/kairos/vignettes/event.Rmd               |   35 
 kairos-2.1.0/kairos/vignettes/seriation.Rmd           |   49 
 28 files changed, 953 insertions(+), 1501 deletions(-)

More information about kairos at CRAN
Permanent link

Package ggedit updated to version 0.4.0 with previous version 0.3.1 dated 2020-06-02

Title: Interactive 'ggplot2' Layer and Theme Aesthetic Editor
Description: Interactively edit 'ggplot2' layer and theme aesthetics definitions.
Author: Jonathan Sidi [aut, cre]
Maintainer: Jonathan Sidi <yonicd@gmail.com>

Diff between ggedit versions 0.3.1 dated 2020-06-02 and 0.4.0 dated 2024-02-26

 ggedit-0.3.1/ggedit/inst/examples/Module              |only
 ggedit-0.3.1/ggedit/man/grapes-greater-than-grapes.Rd |only
 ggedit-0.4.0/ggedit/DESCRIPTION                       |   18 +--
 ggedit-0.4.0/ggedit/MD5                               |   47 +++----
 ggedit-0.4.0/ggedit/NAMESPACE                         |    9 +
 ggedit-0.4.0/ggedit/NEWS.md                           |   66 ++++++-----
 ggedit-0.4.0/ggedit/R/class_layer.R                   |   60 ++++------
 ggedit-0.4.0/ggedit/R/cloneLayer.R                    |   13 --
 ggedit-0.4.0/ggedit/R/cloneProto.R                    |    4 
 ggedit-0.4.0/ggedit/R/clone_facet.R                   |  107 ++++++++----------
 ggedit-0.4.0/ggedit/R/compare.R                       |   42 +++----
 ggedit-0.4.0/ggedit/R/dput.ggedit.R                   |    6 -
 ggedit-0.4.0/ggedit/R/fetch_aes_ggplotBuild.R         |   20 +--
 ggedit-0.4.0/ggedit/R/gg_session.R                    |    8 -
 ggedit-0.4.0/ggedit/R/gg_vetting.R                    |    4 
 ggedit-0.4.0/ggedit/R/remove_geom.R                   |    2 
 ggedit-0.4.0/ggedit/R/rgg.R                           |    4 
 ggedit-0.4.0/ggedit/R/utils.R                         |    4 
 ggedit-0.4.0/ggedit/README.md                         |   20 ++-
 ggedit-0.4.0/ggedit/data/pList.rda                    |binary
 ggedit-0.4.0/ggedit/man/cloneLayer.Rd                 |    4 
 ggedit-0.4.0/ggedit/man/clone_facet.Rd                |    7 -
 ggedit-0.4.0/ggedit/man/remove_geom.Rd                |    2 
 ggedit-0.4.0/ggedit/man/rgg.Rd                        |    4 
 24 files changed, 223 insertions(+), 228 deletions(-)

More information about ggedit at CRAN
Permanent link

Package cwbtools updated to version 0.4.0 with previous version 0.3.9 dated 2023-11-27

Title: Tools to Create, Modify and Manage 'CWB' Corpora
Description: The 'Corpus Workbench' ('CWB', <https://cwb.sourceforge.io/>) offers a classic and mature approach for working with large, linguistically and structurally annotated corpora. The 'CWB' is memory efficient and its design makes running queries fast, see Evert (2011) <https://eprints.lancs.ac.uk/id/eprint/62721>. The 'cwbtools' package offers pure 'R' tools to create indexed corpus files as well as high-level wrappers for the original 'C' implementation of 'CWB' as exposed by the 'RcppCWB' package (<https://CRAN.R-project.org/package=RcppCWB>). Additional functionality to add and modify annotations of corpora from within 'R' makes working with 'CWB' indexed corpora much more flexible and convenient. The 'cwbtools' package in combination with the 'R' packages 'RcppCWB' (<https://CRAN.R-project.org/package=RcppCWB>) and 'polmineR' (<https://CRAN.R-project.org/package=polmineR>) offers a lightweight infrastructure to support the combination of quantitative and qu [...truncated...]
Author: Andreas Blaette [aut, cre], Christoph Leonhardt [aut]
Maintainer: Andreas Blaette <andreas.blaette@uni-due.de>

Diff between cwbtools versions 0.3.9 dated 2023-11-27 and 0.4.0 dated 2024-02-26

 DESCRIPTION                   |   17 -
 MD5                           |   50 +--
 NAMESPACE                     |    9 
 NEWS.md                       |   34 ++
 R/CorpusData.R                |  231 +++++++++++-----
 R/corpus.R                    |  147 ++++++++--
 R/cwb.R                       |  176 ++++++++----
 R/cwbtools.R                  |   21 +
 R/encode.R                    |only
 R/p_attribute.R               |  479 ++++++++++++++++++++++-----------
 R/pkg.R                       |    2 
 R/registry_file.R             |   10 
 R/s_attribute.R               |  225 +++++++++++----
 inst/doc/vignette.R           |  252 +++++++++++------
 inst/doc/vignette.Rmd         |  359 +++++++++++++++---------
 inst/doc/vignette.html        |  604 ++++++++++++++++++++++--------------------
 man/CorpusData.Rd             |   65 ++--
 man/corpus_utils.Rd           |   27 +
 man/cwb.Rd                    |   41 +-
 man/encode.Rd                 |only
 man/p_attribute_encode.Rd     |  162 ++++++-----
 man/pkg_utils.Rd              |    2 
 man/registry_file.Rd          |    7 
 man/s_attribute.Rd            |   86 +++--
 tests/testthat/test_encode.R  |  179 ++++++++++--
 tests/testthat/test_install.R |   29 +-
 vignettes/vignette.Rmd        |  359 +++++++++++++++---------
 27 files changed, 2365 insertions(+), 1208 deletions(-)

More information about cwbtools at CRAN
Permanent link

Package BGmisc updated to version 1.2.0 with previous version 1.0.1 dated 2023-09-26

Title: An R Package for Extended Behavior Genetics Analysis
Description: The BGmisc R package offers a comprehensive suite of functions tailored for extended behavior genetics analysis, including model identification, calculating relatedness, pedigree conversion, pedigree simulation, and more.
Author: S. Mason Garrison [aut, cre] , Michael D. Hunter [aut] , Xuanyu Lyu [aut] , Rachel N. Good [aut] , Jonathan D. Trattner [aut] , S. Alexandra Burt [aut]
Maintainer: S. Mason Garrison <garrissm@wfu.edu>

Diff between BGmisc versions 1.0.1 dated 2023-09-26 and 1.2.0 dated 2024-02-26

 BGmisc-1.0.1/BGmisc/R/identification.R                          |only
 BGmisc-1.0.1/BGmisc/man/BGmisc_package.Rd                       |only
 BGmisc-1.0.1/BGmisc/man/standardize_colnames.Rd                 |only
 BGmisc-1.2.0/BGmisc/DESCRIPTION                                 |   49 -
 BGmisc-1.2.0/BGmisc/MD5                                         |  153 ++--
 BGmisc-1.2.0/BGmisc/NAMESPACE                                   |   11 
 BGmisc-1.2.0/BGmisc/NEWS.md                                     |   17 
 BGmisc-1.2.0/BGmisc/R/BGmisc-package.R                          |   19 
 BGmisc-1.2.0/BGmisc/R/checkIDs.R                                |only
 BGmisc-1.2.0/BGmisc/R/checkSex.R                                |only
 BGmisc-1.2.0/BGmisc/R/cleanPedigree.R                           |only
 BGmisc-1.2.0/BGmisc/R/convertPedigree.R                         |   88 +-
 BGmisc-1.2.0/BGmisc/R/dataDoc.R                                 |   88 +-
 BGmisc-1.2.0/BGmisc/R/evenInsert.R                              |   17 
 BGmisc-1.2.0/BGmisc/R/famSizeCal.R                              |    9 
 BGmisc-1.2.0/BGmisc/R/family.R                                  |  124 +++
 BGmisc-1.2.0/BGmisc/R/formula.R                                 |   19 
 BGmisc-1.2.0/BGmisc/R/helpPedigree.R                            |only
 BGmisc-1.2.0/BGmisc/R/helper.R                                  |   95 +-
 BGmisc-1.2.0/BGmisc/R/identifyModel.R                           |only
 BGmisc-1.2.0/BGmisc/R/plotPedigree.R                            |  117 ++-
 BGmisc-1.2.0/BGmisc/R/simulatePedigree.R                        |  368 +++++-----
 BGmisc-1.2.0/BGmisc/R/tweakPedigree.R                           |only
 BGmisc-1.2.0/BGmisc/README.md                                   |   53 +
 BGmisc-1.2.0/BGmisc/build/vignette.rds                          |binary
 BGmisc-1.2.0/BGmisc/data/hazard.rda                             |binary
 BGmisc-1.2.0/BGmisc/data/inbreeding.rda                         |binary
 BGmisc-1.2.0/BGmisc/data/potter.rda                             |only
 BGmisc-1.2.0/BGmisc/inst/CITATION                               |only
 BGmisc-1.2.0/BGmisc/inst/doc/analyticrelatedness.R              |    4 
 BGmisc-1.2.0/BGmisc/inst/doc/analyticrelatedness.Rmd            |    2 
 BGmisc-1.2.0/BGmisc/inst/doc/analyticrelatedness.html           |    2 
 BGmisc-1.2.0/BGmisc/inst/doc/modelingrelatedness.R              |    2 
 BGmisc-1.2.0/BGmisc/inst/doc/modelingrelatedness.Rmd            |    2 
 BGmisc-1.2.0/BGmisc/inst/doc/modelingrelatedness.html           |   14 
 BGmisc-1.2.0/BGmisc/inst/doc/network.R                          |   46 -
 BGmisc-1.2.0/BGmisc/inst/doc/network.Rmd                        |  131 ++-
 BGmisc-1.2.0/BGmisc/inst/doc/network.html                       |  190 +++--
 BGmisc-1.2.0/BGmisc/inst/doc/pedigree.R                         |   18 
 BGmisc-1.2.0/BGmisc/inst/doc/pedigree.Rmd                       |   33 
 BGmisc-1.2.0/BGmisc/inst/doc/pedigree.html                      |  334 +++++++--
 BGmisc-1.2.0/BGmisc/man/BGmisc-package.Rd                       |only
 BGmisc-1.2.0/BGmisc/man/SimPed.Rd                               |   66 -
 BGmisc-1.2.0/BGmisc/man/adjustKidsPerCouple.Rd                  |only
 BGmisc-1.2.0/BGmisc/man/assignCoupleIds.Rd                      |only
 BGmisc-1.2.0/BGmisc/man/buildBetweenGenerations.Rd              |only
 BGmisc-1.2.0/BGmisc/man/buildWithinGenerations.Rd               |only
 BGmisc-1.2.0/BGmisc/man/calculateRelatedness.Rd                 |  128 +--
 BGmisc-1.2.0/BGmisc/man/checkIDs.Rd                             |only
 BGmisc-1.2.0/BGmisc/man/checkSex.Rd                             |only
 BGmisc-1.2.0/BGmisc/man/comp2vech.Rd                            |    2 
 BGmisc-1.2.0/BGmisc/man/createGenDataFrame.Rd                   |only
 BGmisc-1.2.0/BGmisc/man/determineSex.Rd                         |only
 BGmisc-1.2.0/BGmisc/man/dropLink.Rd                             |only
 BGmisc-1.2.0/BGmisc/man/evenInsert.Rd                           |    4 
 BGmisc-1.2.0/BGmisc/man/fitComponentModel.Rd                    |    2 
 BGmisc-1.2.0/BGmisc/man/hazard.Rd                               |   28 
 BGmisc-1.2.0/BGmisc/man/identifyComponentModel.Rd               |    6 
 BGmisc-1.2.0/BGmisc/man/inbreeding.Rd                           |   33 
 BGmisc-1.2.0/BGmisc/man/inferRelatedness.Rd                     |   64 -
 BGmisc-1.2.0/BGmisc/man/makeInbreeding.Rd                       |only
 BGmisc-1.2.0/BGmisc/man/makeTwins.Rd                            |only
 BGmisc-1.2.0/BGmisc/man/markPotentialChildren.Rd                |only
 BGmisc-1.2.0/BGmisc/man/ped2add.Rd                              |    7 
 BGmisc-1.2.0/BGmisc/man/ped2ce.Rd                               |    2 
 BGmisc-1.2.0/BGmisc/man/ped2cn.Rd                               |    6 
 BGmisc-1.2.0/BGmisc/man/ped2com.Rd                              |   14 
 BGmisc-1.2.0/BGmisc/man/ped2graph.Rd                            |   15 
 BGmisc-1.2.0/BGmisc/man/ped2maternal.Rd                         |only
 BGmisc-1.2.0/BGmisc/man/ped2mit.Rd                              |    7 
 BGmisc-1.2.0/BGmisc/man/ped2paternal.Rd                         |only
 BGmisc-1.2.0/BGmisc/man/plotPedigree.Rd                         |  191 ++---
 BGmisc-1.2.0/BGmisc/man/potter.Rd                               |only
 BGmisc-1.2.0/BGmisc/man/recodeSex.Rd                            |only
 BGmisc-1.2.0/BGmisc/man/repairIDs.Rd                            |only
 BGmisc-1.2.0/BGmisc/man/repairSex.Rd                            |only
 BGmisc-1.2.0/BGmisc/man/resample.Rd                             |only
 BGmisc-1.2.0/BGmisc/man/simulatePedigree.Rd                     |  106 +-
 BGmisc-1.2.0/BGmisc/man/standardizeColnames.Rd                  |only
 BGmisc-1.2.0/BGmisc/man/vech.Rd                                 |    2 
 BGmisc-1.2.0/BGmisc/tests/testthat.R                            |   24 
 BGmisc-1.2.0/BGmisc/tests/testthat/Rplots.pdf                   |only
 BGmisc-1.2.0/BGmisc/tests/testthat/test-BGmisc-package.R        |    6 
 BGmisc-1.2.0/BGmisc/tests/testthat/test-checkIDs.R              |only
 BGmisc-1.2.0/BGmisc/tests/testthat/test-checkSex.R              |only
 BGmisc-1.2.0/BGmisc/tests/testthat/test-evenInsert.R            |only
 BGmisc-1.2.0/BGmisc/tests/testthat/test-famSizeCal.R            |only
 BGmisc-1.2.0/BGmisc/tests/testthat/test-helper.R                |only
 BGmisc-1.2.0/BGmisc/tests/testthat/test-ident.R                 |   34 
 BGmisc-1.2.0/BGmisc/tests/testthat/test-network.R               |   21 
 BGmisc-1.2.0/BGmisc/tests/testthat/test-pedigreesim.R           |   40 +
 BGmisc-1.2.0/BGmisc/tests/testthat/test-relatedness-functions.R |   29 
 BGmisc-1.2.0/BGmisc/tests/testthat/test-tweakPedigree.R         |only
 BGmisc-1.2.0/BGmisc/vignettes/analyticrelatedness.Rmd           |    2 
 BGmisc-1.2.0/BGmisc/vignettes/modelingrelatedness.Rmd           |    2 
 BGmisc-1.2.0/BGmisc/vignettes/network.Rmd                       |  131 ++-
 BGmisc-1.2.0/BGmisc/vignettes/pedigree.Rmd                      |   33 
 97 files changed, 1954 insertions(+), 1056 deletions(-)

More information about BGmisc at CRAN
Permanent link

Package tidyfit updated to version 0.7.0 with previous version 0.6.5 dated 2023-11-20

Title: Regularized Linear Modeling with Tidy Data
Description: An extension to the 'R' tidy data environment for automated machine learning. The package allows fitting and cross validation of linear regression and classification algorithms on grouped data.
Author: Johann Pfitzinger [aut, cre]
Maintainer: Johann Pfitzinger <johann.pfitzinger@gmail.com>

Diff between tidyfit versions 0.6.5 dated 2023-11-20 and 0.7.0 dated 2024-02-26

 DESCRIPTION                                         |   22 +-
 MD5                                                 |   91 +++++----
 NAMESPACE                                           |    8 
 NEWS.md                                             |   11 +
 R/check_explain_method.R                            |only
 R/check_method.R                                    |   26 +-
 R/check_package_name.R                              |    2 
 R/classify.R                                        |    2 
 R/coef.tidyfit.models.R                             |   12 -
 R/coef_methods.R                                    |    6 
 R/eval_metrics.R                                    |    7 
 R/explain.R                                         |only
 R/explain.tidyfit.models.R                          |only
 R/explain_methods.R                                 |only
 R/fit.anova.R                                       |only
 R/fit.gets.R                                        |    4 
 R/fit.glmm.R                                        |   19 +
 R/fit.lm.R                                          |    2 
 R/fit.nnet.R                                        |only
 R/fit.quantile.R                                    |    2 
 R/fit.quantile_rf.R                                 |    5 
 R/fit.rf.R                                          |   35 ---
 R/fit.svm.R                                         |   13 -
 R/fit_groups.R                                      |    2 
 R/generics.R                                        |    5 
 R/m.R                                               |   10 -
 R/model_definition.R                                |   76 +++++++
 R/post_process.R                                    |    6 
 R/predict.tidyfit.models.R                          |   22 +-
 R/predict_methods.R                                 |    1 
 R/regress.R                                         |    2 
 R/residuals.tidyfit.models.R                        |   12 -
 R/utils.R                                           |   22 --
 README.md                                           |   44 +++-
 inst/doc/Accessing_Fitted_Model_Objects.html        |   96 ++++-----
 inst/doc/Feature_Selection.R                        |   10 -
 inst/doc/Feature_Selection.Rmd                      |   10 -
 inst/doc/Feature_Selection.html                     |   10 -
 inst/doc/Predicting_Boston_House_Prices.html        |  200 ++++++++++----------
 inst/doc/Rolling_Window_Time_Series_Regression.html |   40 ++--
 man/dot-fit.anova.Rd                                |only
 man/dot-fit.nnet.Rd                                 |only
 man/dot-fit.quantile_rf.Rd                          |    2 
 man/dot-fit.rf.Rd                                   |    2 
 man/explain.Rd                                      |only
 man/explain.tidyfit.models.Rd                       |only
 man/figures/README-unnamed-chunk-14-1.png           |binary
 man/m.Rd                                            |    4 
 tests/testthat/test-quantile_rf.R                   |    2 
 tests/testthat/test-rf.R                            |    8 
 tests/testthat/test-svm.R                           |only
 vignettes/Feature_Selection.Rmd                     |   10 -
 52 files changed, 499 insertions(+), 364 deletions(-)

More information about tidyfit at CRAN
Permanent link

New package Unico with initial version 0.1.0
Package: Unico
Title: Unified Cross-Omics Deconvolution
Version: 0.1.0
Description: UNIfied Cross-Omics deconvolution (Unico) deconvolves standard 2-dimensional bulk matrices of samples by features into a 3-dimensional tensors representing samples by features by cell types. Unico stands out as the first principled model-based deconvolution method that is theoretically justified for any heterogeneous genomic data. For more details see Chen and Rahmani et al. (2024) <doi:10.1101/2024.01.27.577588>.
License: GPL-3
URL: https://cozygene.github.io/Unico/
BugReports: https://github.com/cozygene/Unico/issues
Depends: R (>= 4.0.0)
Imports: compositions, config, data.table, futile.logger, MASS, matrixcalc, matrixStats, mgcv, nloptr, parallel, pbapply, pracma, stats, testit, utils
Suggests: egg, hexbin, knitr, rmarkdown, testthat (>= 3.0.0)
VignetteBuilder: knitr, rmarkdown
Encoding: UTF-8
NeedsCompilation: no
Packaged: 2024-02-23 18:25:07 UTC; johnsonchen
Author: Zeyuan Chen [aut, cre], Elior Rahmani [aut]
Maintainer: Zeyuan Chen <johnsonchen@cs.ucla.edu>
Repository: CRAN
Date/Publication: 2024-02-26 16:50:06 UTC

More information about Unico at CRAN
Permanent link

New package smcryptoR with initial version 0.1.1
Package: smcryptoR
Title: ShangMi(SM) Cryptographic Algorithms(SM2/SM3/SM4)
Version: 0.1.1
Description: Bindings to 'smcrypto' <https://github.com/zhuobie/smcrypto>: a 'Rust' implementation of China's Standards of Encryption Algorithms, which is usually called 'ShangMi(SM)' algorithms. It contains 'SM3' message digest algorithm, 'SM2' asymmetric encryption algorithm and 'SM4' symmetric encryption algorithm. Users can do message hash, encrypt/decrypt, sign/verify, key exchange and more.
License: MIT + file LICENSE
URL: https://github.com/zhuobie/smcryptoR
BugReports: https://github.com/zhuobie/smcryptoR/issues
Depends: R (>= 4.2)
SystemRequirements: Cargo (Rust's package manager), rustc
Biarch: true
NeedsCompilation: yes
Packaged: 2024-02-23 10:11:00 UTC; yumeng
Maintainer: Meng Yu <610074@gmail.com>
Repository: CRAN
Date/Publication: 2024-02-26 16:30:04 UTC
Suggests: knitr, rmarkdown
VignetteBuilder: knitr
Author: Meng Yu [aut, cre]

More information about smcryptoR at CRAN
Permanent link

New package sanketphonetictranslator with initial version 0.1.0
Package: sanketphonetictranslator
Title: Phonetic Transliteration Between Hindi and English
Version: 0.1.0
Description: Facilitate phonetic transliteration between different languages. With support for both Hindi and English, this package provides a way to convert text between Hindi and English dataset. Whether you're working with multilingual data or need to convert dataset for analysis or presentation purposes, it offers a simple and efficient solution and harness the power of phonetic transliteration in your projects with this versatile package.
License: AGPL (>= 3)
Encoding: UTF-8
Imports: Rcpp, readr, stringi, stringr, utils
Depends: R (>= 2.10)
Suggests: knitr, rmarkdown
VignetteBuilder: knitr
LazyData: true
NeedsCompilation: no
Packaged: 2024-02-23 06:44:49 UTC; user
Author: Sanket Gharat [aut, cre]
Maintainer: Sanket Gharat <sanketgharat234@gmail.com>
Repository: CRAN
Date/Publication: 2024-02-26 16:20:07 UTC

More information about sanketphonetictranslator at CRAN
Permanent link

Package rPBK updated to version 0.2.4 with previous version 0.2.3 dated 2024-02-01

Title: Inference and Prediction of Generic Physiologically-Based Kinetic Models
Description: Fit and simulate any kind of physiologically-based kinetic ('PBK') models whatever the number of compartments. Moreover, it allows to account for any link between pairs of compartments, as well as any link of each of the compartments with the external medium. Such generic PBK models have today applications in pharmacology (PBPK models) to describe drug effects, in toxicology and ecotoxicology (PBTK models) to describe chemical substance effects. In case of exposure to a parent compound (drug or chemical) the 'rPBK' package allows to consider metabolites, whatever their number and their phase (I, II, ...). Last but not least, package 'rPBK' can also be used for dynamic flux balance analysis (dFBA) to deal with metabolic networks. See also Charles et al. (2022) <doi:10.1101/2022.04.29.490045>.
Author: Virgile Baudrot [aut, cre], Sandrine Charles [aut], Christelle Lopes [aut], Ophelia Gestin [ctb], Dominique Lamonica [ctb], Aurelie Siberchicot [ctb]
Maintainer: Virgile Baudrot <virgile.baudrot@qonfluens.com>

Diff between rPBK versions 0.2.3 dated 2024-02-01 and 0.2.4 dated 2024-02-26

 DESCRIPTION            |   10 +--
 MD5                    |    8 +-
 R/rPBK-package.R       |    8 +-
 README.md              |    1 
 inst/doc/Examples.html |  136 +++++++++++++++++++++++++------------------------
 5 files changed, 84 insertions(+), 79 deletions(-)

More information about rPBK at CRAN
Permanent link

New package Rapi with initial version 1.0.4
Package: Rapi
Title: Interface for Multiple Data Providers 'EDDS' and 'FRED'
Version: 1.0.4
Date: 2024-02-19
Maintainer: Sermet Pekin <sermetpekin@gmail.com>
URL: https://github.com/DataRapi/Rapi, https://DataRapi.github.io/Rapi/
BugReports: https://github.com/DataRapi/Rapi/issues
Description: Interface for multiple data sources, such as the 'EDDS' API <https://evds2.tcmb.gov.tr/index.php?/evds/userDocs> of the Central Bank of the Republic of Türkiye and the 'FRED' API <https://fred.stlouisfed.org/docs/api/fred/> of the Federal Reserve Bank. Both data providers require API keys for access, which users can easily obtain by creating accounts on their respective websites. The package provides caching ability with the selection of periods to increase the speed and efficiency of requests. It combines datasets requested from different sources, helping users when the data has common frequencies. While combining data frames whenever possible, it also keeps all requested data available as separate data frames to increase efficiency.
License: MIT + file LICENSE
LinkingTo: Rcpp
Depends: R (>= 3.4.3), Rcpp
Imports: crayon, digest, dplyr, httr, httr2, glue, jsonlite, lubridate, magrittr, purrr, rlang, rlist, stringr, tibble
Suggests: writexl , devtools, testthat
Encoding: UTF-8
NeedsCompilation: yes
Packaged: 2024-02-23 04:32:22 UTC; sermetpekin
Author: Sermet Pekin [aut, cre, cph]
Repository: CRAN
Date/Publication: 2024-02-26 16:20:09 UTC

More information about Rapi at CRAN
Permanent link

New package comets with initial version 0.0-1
Package: comets
Title: Covariance Measure Tests for Conditional Independence
Version: 0.0-1
Description: Covariance measure tests for conditional independence testing against conditional covariance and nonlinear conditional mean alternatives. Contains versions of the generalised covariance measure test (Shah and Peters, 2020, <doi:10.1214/19-aos1857>) and projected covariance measure test (Lundborg et al., 2023, <doi:10.48550/arXiv.2211.02039>). Applications can be found in Kook and Lundborg (2024, <doi:10.48550/arXiv.2402.14416>).
Imports: ranger, glmnet, Formula
License: GPL-3
Encoding: UTF-8
Suggests: testthat (>= 3.0.0), ggplot2, tidyr, dplyr
NeedsCompilation: no
Packaged: 2024-02-23 11:32:04 UTC; stigler
Author: Lucas Kook [aut, cre], Anton Rask Lundborg [ctb]
Maintainer: Lucas Kook <lucasheinrich.kook@gmail.com>
Repository: CRAN
Date/Publication: 2024-02-26 16:30:15 UTC

More information about comets at CRAN
Permanent link

New package cards with initial version 0.1.0
Package: cards
Title: Analysis Results Data
Version: 0.1.0
Description: Construct Clinical Data Interchange Standards Consortium (CDISC) compliant Analysis Results Data objects. These objects are used and re-used to construct summary tables, visualizations, and written reports. The package also exports utilities for working with these objects and creating new Analysis Results Data objects.
License: Apache License 2.0
URL: https://github.com/insightsengineering/cards, https://insightsengineering.github.io/cards/
BugReports: https://github.com/insightsengineering/cards/issues
Depends: R (>= 4.1)
Imports: cli (>= 3.6.1), dplyr (>= 1.1.2), glue (>= 1.6.2), rlang (>= 1.1.1), tidyr (>= 1.3.0), tidyselect (>= 1.2.0)
Suggests: spelling (>= 2.2.0), testthat (>= 3.2.0), withr (>= 3.0.0)
Encoding: UTF-8
Language: en-US
LazyData: true
NeedsCompilation: no
Packaged: 2024-02-23 19:34:31 UTC; sjobergd
Author: Daniel D. Sjoberg [aut, cre] , Becca Krouse [aut], F. Hoffmann-La Roche AG [cph, fnd]
Maintainer: Daniel D. Sjoberg <danield.sjoberg@gmail.com>
Repository: CRAN
Date/Publication: 2024-02-26 16:50:02 UTC

More information about cards at CRAN
Permanent link

New package BayesCVI with initial version 1.0.0
Package: BayesCVI
Title: Bayesian Cluster Validity Index
Version: 1.0.0
Imports: e1071, mclust, ggplot2, UniversalCVI
Description: Algorithms for computing and generating plots with and without error bars for Bayesian cluster validity index (BCVI) (N. Wiroonsri, O. Preedasawakul (2024) <arXiv:2402.02162>) based on several underlying cluster validity indexes (CVIs) including Calinski-Harabasz, Chou-Su-Lai, Davies-Bouldin, Dunn, Pakhira-Bandyopadhyay-Maulik, Point biserial correlation, the score function, Starczewski, and Wiroonsri indices for hard clustering, and Correlation Cluster Validity, the generalized C, HF, KWON, KWON2, Modified Pakhira-Bandyopadhyay-Maulik, Pakhira-Bandyopadhyay-Maulik, Tang, Wiroonsri-Preedasawakul, Wu-Li, and Xie-Beni indices for soft clustering. The package is compatible with K-means, fuzzy C means, EM clustering, and hierarchical clustering (single, average, and complete linkage). Though BCVI is compatible with any underlying existing CVIs, we recommend users to use either WI or WP as the underlying CVI.
License: GPL (>= 3)
Encoding: UTF-8
LazyData: true
Depends: R (>= 2.10)
NeedsCompilation: no
Packaged: 2024-02-23 03:38:32 UTC; lenovo
Author: Nathakhun Wiroonsri [aut] , Onthada Preedasawakul [cre, aut]
Maintainer: Onthada Preedasawakul <o.preedasawakul@gmail.com>
Repository: CRAN
Date/Publication: 2024-02-26 16:20:12 UTC

More information about BayesCVI at CRAN
Permanent link

Package cgrcusum (with last version 0.1.0) was removed from CRAN

Previous versions (as known to CRANberries) which should be available via the Archive link are:

2021-11-22 0.1.0

Permanent link
Package TruncExpFam updated to version 1.1.1 with previous version 1.1.0 dated 2023-11-14

Title: Truncated Exponential Family
Description: Handles truncated members from the exponential family of probability distributions. Contains functions such as rtruncnorm() and dtruncpois(), which are truncated versions of rnorm() and dpois() from the stats package that also offer richer output containing, for example, the distribution parameters. It also provides functions to retrieve the original distribution parameters from a truncated sample by maximum-likelihood estimation.
Author: Rene Holst [aut], Waldir Leoncio [cre, aut]
Maintainer: Waldir Leoncio <w.l.netto@medisin.uio.no>

Diff between TruncExpFam versions 1.1.0 dated 2023-11-14 and 1.1.1 dated 2024-02-26

 DESCRIPTION                              |    8 -
 MD5                                      |   16 +-
 NEWS.md                                  |    4 
 R/a_rtrunc.R                             |    2 
 R/rtrunc_direct.R                        |  222 +++++++++++++++++++------------
 inst/doc/Sampling_and_ML_estimation.html |    2 
 man/TruncExpFam.Rd                       |    2 
 man/rtrunc.Rd                            |    4 
 tests/testthat/test-direct-sampling.R    |   24 +--
 9 files changed, 174 insertions(+), 110 deletions(-)

More information about TruncExpFam at CRAN
Permanent link

Package ipumsr updated to version 0.7.1 with previous version 0.7.0 dated 2023-10-20

Title: An R Interface for Downloading, Reading, and Handling IPUMS Data
Description: An easy way to work with census, survey, and geographic data provided by IPUMS in R. Generate and download data through the IPUMS API and load IPUMS files into R with their associated metadata to make analysis easier. IPUMS data describing 1.4 billion individuals drawn from over 750 censuses and surveys is available free of charge from the IPUMS website <https://www.ipums.org>.
Author: Greg Freedman Ellis [aut], Derek Burk [aut, cre], Finn Roberts [aut], Joe Grover [ctb], Dan Ehrlich [ctb], Renae Rodgers [ctb], Institute for Social Research and Data Innovation [cph]
Maintainer: Derek Burk <ipums+cran@umn.edu>

Diff between ipumsr versions 0.7.0 dated 2023-10-20 and 0.7.1 dated 2024-02-26

 DESCRIPTION                                      |   10 
 MD5                                              |   91 +++---
 NEWS.md                                          |    4 
 R/api_process_extract.R                          |    2 
 R/micro_read_chunked.R                           |   36 +-
 R/viewer.R                                       |    6 
 README.md                                        |  318 ++++++++++++++++++---
 inst/doc/ipums-api-micro.R                       |    6 
 inst/doc/ipums-api-micro.Rmd                     |   17 -
 inst/doc/ipums-api-micro.html                    |   26 -
 inst/doc/ipums-api-nhgis.R                       |   36 +-
 inst/doc/ipums-api-nhgis.Rmd                     |   76 ++---
 inst/doc/ipums-api-nhgis.html                    |  138 ++++-----
 inst/doc/ipums-api.R                             |   10 
 inst/doc/ipums-api.Rmd                           |   26 -
 inst/doc/ipums-api.html                          |   28 -
 inst/doc/ipums-bigdata.R                         |   93 ++----
 inst/doc/ipums-bigdata.Rmd                       |   57 +--
 inst/doc/ipums-bigdata.html                      |  113 +++++--
 inst/doc/ipums-read.R                            |    1 
 inst/doc/ipums-read.Rmd                          |   76 ++---
 inst/doc/ipums-read.html                         |  127 +++-----
 inst/doc/ipums.R                                 |    7 
 inst/doc/ipums.Rmd                               |  129 +++++---
 inst/doc/ipums.html                              |  204 +++++++-------
 inst/doc/value-labels.R                          |    2 
 inst/doc/value-labels.Rmd                        |   39 +-
 inst/doc/value-labels.html                       |  109 +++----
 man/figures/check-solid.svg                      |only
 man/figures/logo-square_cps_50x50.png            |only
 man/figures/logo-square_global-health_50x50.png  |only
 man/figures/logo-square_health-surveys_50x50.png |only
 man/figures/logo-square_higher-ed_50x50.png      |only
 man/figures/logo-square_ihgis_50x50.png          |only
 man/figures/logo-square_international_50x50.png  |only
 man/figures/logo-square_nhgis50x50.png           |only
 man/figures/logo-square_time-use_50x50.png       |only
 man/figures/logo-square_usa_50x50.png            |only
 man/ipums_callback.Rd                            |  335 -----------------------
 man/read_ipums_micro_chunked.Rd                  |   36 +-
 man/read_ipums_micro_yield.Rd                    |   88 ------
 tests/testthat/test_api_helpers.R                |    6 
 tests/testthat/test_api_process_extract.R        |    6 
 tests/testthat/test_nhgis.R                      |    2 
 vignettes/cps_select_data.jpg                    |only
 vignettes/ipums-api-micro.Rmd                    |   17 -
 vignettes/ipums-api-nhgis.Rmd                    |   76 ++---
 vignettes/ipums-api.Rmd                          |   26 -
 vignettes/ipums-bigdata.Rmd                      |   57 +--
 vignettes/ipums-read.Rmd                         |   76 ++---
 vignettes/ipums.Rmd                              |  129 +++++---
 vignettes/value-labels.Rmd                       |   39 +-
 52 files changed, 1245 insertions(+), 1435 deletions(-)

More information about ipumsr at CRAN
Permanent link

Package cocorresp updated to version 0.4-4 with previous version 0.4-3 dated 2021-05-07

Title: Co-Correspondence Analysis Methods
Description: Fits predictive and symmetric co-correspondence analysis (CoCA) models to relate one data matrix to another data matrix. More specifically, CoCA maximises the weighted covariance between the weighted averaged species scores of one community and the weighted averaged species scores of another community. CoCA attempts to find patterns that are common to both communities.
Author: Original Matlab routines by C.J.F. ter Braak and A.P. Schaffers. R port by Gavin L. Simpson. Function simpls based on simpls.fit by Ron Wehrens and Bjorn-Helge Mevik.
Maintainer: Gavin L. Simpson <ucfagls@gmail.com>

Diff between cocorresp versions 0.4-3 dated 2021-05-07 and 0.4-4 dated 2024-02-26

 DESCRIPTION                           |   10 +--
 MD5                                   |   28 ++++----
 R/mcChi.R                             |    2 
 README.md                             |    3 
 build/vignette.rds                    |binary
 data/beetles.rda                      |binary
 data/bryophyte.rda                    |binary
 data/plants.rda                       |binary
 data/vascular.rda                     |binary
 inst/CITATION                         |   20 +++---
 inst/ChangeLog                        |    4 +
 inst/doc/cocorresp-intro.html         |  108 +++++++++++++---------------------
 man/cocorresp-internal.Rd             |    9 --
 man/permutest.coca.Rd                 |    4 -
 tests/Examples/cocorresp-Ex.Rout.save |   20 +++---
 15 files changed, 91 insertions(+), 117 deletions(-)

More information about cocorresp at CRAN
Permanent link

Package transformr updated to version 0.1.5 with previous version 0.1.4 dated 2022-08-18

Title: Polygon and Path Transformations
Description: In order to smoothly animate the transformation of polygons and paths, many aspects needs to be taken into account, such as differing number of control points, changing center of rotation, etc. The 'transformr' package provides an extensive framework for manipulating the shapes of polygons and paths and can be seen as the spatial brother to the 'tweenr' package.
Author: Thomas Lin Pedersen [cre, aut]
Maintainer: Thomas Lin Pedersen <thomasp85@gmail.com>

Diff between transformr versions 0.1.4 dated 2022-08-18 and 0.1.5 dated 2024-02-26

 transformr-0.1.4/transformr/src/Makevars        |only
 transformr-0.1.5/transformr/DESCRIPTION         |    9 +++----
 transformr-0.1.5/transformr/MD5                 |   13 ++++------
 transformr-0.1.5/transformr/NAMESPACE           |    3 ++
 transformr-0.1.5/transformr/NEWS.md             |    4 +++
 transformr-0.1.5/transformr/R/tween_sf.R        |   29 +++++++++++++++++++++---
 transformr-0.1.5/transformr/src/align_rings.cpp |    2 -
 transformr-0.1.5/transformr/src/sf_packing.cpp  |   12 ++++-----
 8 files changed, 49 insertions(+), 23 deletions(-)

More information about transformr at CRAN
Permanent link

New package RprobitB with initial version 1.1.4
Package: RprobitB
Title: Bayesian Probit Choice Modeling
Version: 1.1.4
Description: Bayes estimation of probit choice models, both in the cross-sectional and panel setting. The package can analyze binary, multivariate, ordered, and ranked choices, as well as heterogeneity of choice behavior among deciders. The main functionality includes model fitting via Markov chain Monte Carlo m ethods, tools for convergence diagnostic, choice data simulation, in-sample and out-of-sample choice prediction, and model selection using information criteria and Bayes factors. The latent class model extension facilitates preference-based decider classification, where the number of latent classes can be inferred via the Dirichlet process or a weight-based updating heuristic. This allows for flexible modeling of choice behavior without the need to impose structural constraints. For a reference on the method see Oelschlaeger and Bauer (2021) <https://trid.trb.org/view/1759753>.
URL: https://loelschlaeger.de/RprobitB/, https://github.com/loelschlaeger/RprobitB
BugReports: https://github.com/loelschlaeger/RprobitB/issues
License: GPL-3
Encoding: UTF-8
Imports: checkmate, cli, crayon, doSNOW, foreach, ggplot2, graphics, gridExtra, MASS, mixtools, mvtnorm, oeli (>= 0.4.1), parallel, plotROC, progress, Rcpp, Rdpack, rlang, stats, utils, viridis
LinkingTo: Rcpp, RcppArmadillo
Suggests: knitr, mlogit, testthat (>= 3.0.0)
Depends: R (>= 3.5.0)
VignetteBuilder: knitr
LazyData: true
LazyDataCompression: xz
NeedsCompilation: yes
Packaged: 2024-02-26 10:52:22 UTC; loelschlaeger@ad.uni-bielefeld.de
Author: Lennart Oelschlaeger [aut, cre] , Dietmar Bauer [aut] , Sebastian Buescher [ctb], Manuel Batram [ctb]
Maintainer: Lennart Oelschlaeger <oelschlaeger.lennart@gmail.com>
Repository: CRAN
Date/Publication: 2024-02-26 14:10:06 UTC

More information about RprobitB at CRAN
Permanent link

Package rpart.plot updated to version 3.1.2 with previous version 3.1.1 dated 2022-05-21

Title: Plot 'rpart' Models: An Enhanced Version of 'plot.rpart'
Description: Plot 'rpart' models. Extends plot.rpart() and text.rpart() in the 'rpart' package.
Author: Stephen Milborrow
Maintainer: Stephen Milborrow <milbo@sonic.net>

Diff between rpart.plot versions 3.1.1 dated 2022-05-21 and 3.1.2 dated 2024-02-26

 rpart.plot-3.1.1/rpart.plot/NEWS                                      |only
 rpart.plot-3.1.2/rpart.plot/DESCRIPTION                               |    6 -
 rpart.plot-3.1.2/rpart.plot/MD5                                       |   58 +++++-----
 rpart.plot-3.1.2/rpart.plot/NEWS.md                                   |only
 rpart.plot-3.1.2/rpart.plot/R/as.char.R                               |    8 -
 rpart.plot-3.1.2/rpart.plot/R/lib.R                                   |    2 
 rpart.plot-3.1.2/rpart.plot/R/lib.rpart.plot.R                        |    6 -
 rpart.plot-3.1.2/rpart.plot/R/node.labs.R                             |   12 +-
 rpart.plot-3.1.2/rpart.plot/R/palette.R                               |   28 ++--
 rpart.plot-3.1.2/rpart.plot/R/prp.R                                   |    2 
 rpart.plot-3.1.2/rpart.plot/R/rpart.rules.R                           |   20 +--
 rpart.plot-3.1.2/rpart.plot/R/split.labs.R                            |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/make.bat                   |   46 +++----
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/makeclean.bat              |    6 -
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/rpart.report.bat           |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.describe.col.bat      |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.imports.bat           |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.na.bat                |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.palette.Rout.save     |    1 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.palette.bat           |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.rpart.plot.Rout.save  |   36 ++----
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.rpart.plot.bat        |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.rpart.rules.Rout.save |    1 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.rpart.rules.bat       |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/test.type5.bat             |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/usersplits.bat             |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/vignette.Rout.save         |    3 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/vignette.bat               |    2 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/webpage.figs.Rout.save     |    1 
 rpart.plot-3.1.2/rpart.plot/inst/slowtests/webpage.figs.bat           |    2 
 rpart.plot-3.1.2/rpart.plot/man/prp.Rd                                |    2 
 31 files changed, 129 insertions(+), 133 deletions(-)

More information about rpart.plot at CRAN
Permanent link

Package pcutils updated to version 0.2.3 with previous version 0.2.0 dated 2024-01-09

Title: Some Useful Functions for Statistics and Visualization
Description: Offers a range of utilities and functions for everyday programming tasks. 1.Data Manipulation. Such as grouping and merging, column splitting, and character expansion. 2.File Handling. Read and convert files in popular formats, including "blast", "diamond", "fasta", "gff", "gtf", and various image formats like "jpg", "png", "pdf", and "svg". 3.Plotting Assistance. Helpful utilities for generating color palettes, validating color formats, and adding transparency. 4.Statistical Analysis. Includes functions for pairwise comparisons and multiple testing corrections, enabling perform statistical analyses with ease. 5.Graph Plotting, Provides efficient tools for creating doughnut plot and multi-layered doughnut plot; Venn diagrams, including traditional Venn diagrams, upset plots, and flower plots; Simplified functions for creating stacked bar plots, or a box plot with alphabets group for multiple comparison group.
Author: Chen Peng [aut, cre]
Maintainer: Chen Peng <pengchen2001@zju.edu.cn>

Diff between pcutils versions 0.2.0 dated 2024-01-09 and 0.2.3 dated 2024-02-26

 pcutils-0.2.0/pcutils/man/DNA_plot.Rd                 |only
 pcutils-0.2.0/pcutils/man/Olympic_rings.Rd            |only
 pcutils-0.2.0/pcutils/man/chunlian.Rd                 |only
 pcutils-0.2.0/pcutils/man/ggheatmap.Rd                |only
 pcutils-0.2.0/pcutils/man/give_you_a_rose.Rd          |only
 pcutils-0.2.0/pcutils/man/tax_wordcloud.Rd            |only
 pcutils-0.2.0/pcutils/man/triangp.Rd                  |only
 pcutils-0.2.3/pcutils/DESCRIPTION                     |   29 
 pcutils-0.2.3/pcutils/MD5                             |   48 -
 pcutils-0.2.3/pcutils/NAMESPACE                       |   20 
 pcutils-0.2.3/pcutils/R/l_tools.R                     |  310 ++++++---
 pcutils-0.2.3/pcutils/R/pcutils-package.R             |    3 
 pcutils-0.2.3/pcutils/R/plots.R                       |  583 ++++--------------
 pcutils-0.2.3/pcutils/R/project.R                     |  394 +++++++++++-
 pcutils-0.2.3/pcutils/data/otutab.rda                 |binary
 pcutils-0.2.3/pcutils/inst/doc/pcutils.R              |    2 
 pcutils-0.2.3/pcutils/inst/doc/pcutils.Rmd            |    2 
 pcutils-0.2.3/pcutils/inst/doc/pcutils.html           |    9 
 pcutils-0.2.3/pcutils/man/download2.Rd                |    7 
 pcutils-0.2.3/pcutils/man/gghuan2.Rd                  |   12 
 pcutils-0.2.3/pcutils/man/ggplot_translator.Rd        |only
 pcutils-0.2.3/pcutils/man/gsub.data.frame.Rd          |    2 
 pcutils-0.2.3/pcutils/man/how_to_set_font_for_plot.Rd |only
 pcutils-0.2.3/pcutils/man/plotgif.Rd                  |    6 
 pcutils-0.2.3/pcutils/man/prepare_package.Rd          |only
 pcutils-0.2.3/pcutils/man/read.file.Rd                |   13 
 pcutils-0.2.3/pcutils/man/split_text.Rd               |only
 pcutils-0.2.3/pcutils/man/tidai.Rd                    |    8 
 pcutils-0.2.3/pcutils/man/translator.Rd               |   16 
 pcutils-0.2.3/pcutils/man/update_NEWS_md.Rd           |only
 pcutils-0.2.3/pcutils/vignettes/pcutils.Rmd           |    2 
 31 files changed, 824 insertions(+), 642 deletions(-)

More information about pcutils at CRAN
Permanent link

Package NADA2 updated to version 1.1.6 with previous version 1.1.5 dated 2023-10-20

Title: Data Analysis for Censored Environmental Data
Description: Contains methods described by Dennis Helsel in his book "Statistics for Censored Environmental Data using Minitab and R" (2011) and courses and videos at <https://practicalstats.com>. This package adds new functions to the `NADA` Package.
Author: Paul Julian [aut, cre], Dennis Helsel [aut, cph]
Maintainer: Paul Julian <pauljulianphd@gmail.com>

Diff between NADA2 versions 1.1.5 dated 2023-10-20 and 1.1.6 dated 2024-02-26

 DESCRIPTION                          |    8 +-
 MD5                                  |   22 +++---
 NEWS.md                              |   12 +++
 R/Pollen_Thia.R                      |    4 -
 R/cen1way.R                          |    4 -
 R/cfit.R                             |  125 +++++++++++++++++++----------------
 build/partial.rdb                    |binary
 inst/doc/Censored_Data_Analysis.Rmd  |    2 
 inst/doc/Censored_Data_Analysis.html |   96 +++++++++++++-------------
 man/Pollen_Thia.Rd                   |    5 -
 man/cfit.Rd                          |   19 ++---
 vignettes/Censored_Data_Analysis.Rmd |    2 
 12 files changed, 158 insertions(+), 141 deletions(-)

More information about NADA2 at CRAN
Permanent link

Package ggfields updated to version 0.0.6 with previous version 0.0.3 dated 2024-02-02

Title: Add Vector Field Layers to Ggplots
Description: Add vector field layers to ggplots. Ideal for visualising wind speeds, water currents, electric/magnetic fields, etc. Accepts data.frames, simple features (sf), and spatiotemporal arrays (stars) objects as input. Vector fields are depicted as arrows starting at specified locations, and with specified angles and radii.
Author: Pepijn de Vries [aut, cre]
Maintainer: Pepijn de Vries <pepijn.devries@outlook.com>

Diff between ggfields versions 0.0.3 dated 2024-02-02 and 0.0.6 dated 2024-02-26

 DESCRIPTION                  |   12 ++++++------
 MD5                          |   14 +++++++-------
 NEWS.md                      |    6 ++++++
 R/angle_correction.r         |   32 ++++++++++++++++++++------------
 README.md                    |    6 +++---
 man/angle_correction.Rd      |   32 ++++++++++++++++++++------------
 man/figures/README-map-1.svg |    2 +-
 man/ggfields-package.Rd      |    2 +-
 8 files changed, 64 insertions(+), 42 deletions(-)

More information about ggfields at CRAN
Permanent link

Package FRK updated to version 2.2.2 with previous version 2.2.1 dated 2024-01-09

Title: Fixed Rank Kriging
Description: A tool for spatial/spatio-temporal modelling and prediction with large datasets. The approach models the field, and hence the covariance function, using a set of basis functions. This fixed-rank basis-function representation facilitates the modelling of big data, and the method naturally allows for non-stationary, anisotropic covariance functions. Discretisation of the spatial domain into so-called basic areal units (BAUs) facilitates the use of observations with varying support (i.e., both point-referenced and areal supports, potentially simultaneously), and prediction over arbitrary user-specified regions. `FRK` also supports inference over various manifolds, including the 2D plane and 3D sphere, and it provides helper functions to model, fit, predict, and plot with relative ease. Version 2.0.0 and above also supports the modelling of non-Gaussian data (e.g., Poisson, binomial, negative-binomial, gamma, and inverse-Gaussian) by employing a generalised linear mixed model (GLMM) framew [...truncated...]
Author: Andrew Zammit-Mangion [aut, cre], Matthew Sainsbury-Dale [aut]
Maintainer: Andrew Zammit-Mangion <andrewzm@gmail.com>

Diff between FRK versions 2.2.1 dated 2024-01-09 and 2.2.2 dated 2024-02-26

 FRK-2.2.1/FRK/vignettes/FRK_intro.fdb_latexmk |only
 FRK-2.2.1/FRK/vignettes/FRK_intro.fls         |only
 FRK-2.2.2/FRK/DESCRIPTION                     |    8 +-
 FRK-2.2.2/FRK/MD5                             |   26 +++-----
 FRK-2.2.2/FRK/data/AIRS_05_2003.rda           |binary
 FRK-2.2.2/FRK/data/Am_data.rda                |binary
 FRK-2.2.2/FRK/data/MODIS_cloud_df.rda         |binary
 FRK-2.2.2/FRK/data/NOAA_df_1990.rda           |binary
 FRK-2.2.2/FRK/data/isea3h.rda                 |binary
 FRK-2.2.2/FRK/data/worldmap.rda               |binary
 FRK-2.2.2/FRK/inst/doc/FRK_intro.R            |   82 ++++++++++++++++++--------
 FRK-2.2.2/FRK/inst/doc/FRK_intro.Rnw          |   82 ++++++++++++++++++--------
 FRK-2.2.2/FRK/inst/doc/FRK_intro.pdf          |binary
 FRK-2.2.2/FRK/inst/doc/FRK_non-Gaussian.pdf   |binary
 FRK-2.2.2/FRK/vignettes/FRK_intro.Rnw         |   82 ++++++++++++++++++--------
 15 files changed, 190 insertions(+), 90 deletions(-)

More information about FRK at CRAN
Permanent link

Package folio updated to version 1.4.0 with previous version 1.3.0 dated 2022-10-31

Title: Datasets for Teaching Archaeology and Paleontology
Description: Datasets for teaching quantitative approaches and modeling in archaeology and paleontology. This package provides several types of data related to broad topics (cultural evolution, radiocarbon dating, paleoenvironments, etc.), which can be used to illustrate statistical methods in the classroom (multivariate data analysis, compositional data analysis, diversity measurement, etc.).
Author: Nicolas Frerebeau [aut, cre] , Brice Lebrun [ctb] , Universite Bordeaux Montaigne [fnd], CNRS [fnd]
Maintainer: Nicolas Frerebeau <nicolas.frerebeau@u-bordeaux-montaigne.fr>

Diff between folio versions 1.3.0 dated 2022-10-31 and 1.4.0 dated 2024-02-26

 DESCRIPTION          |   50 +++++++--------
 MD5                  |   85 +++++++++++++------------
 NEWS.md              |    5 +
 R/artefacts.R        |   32 ++++-----
 R/carbon.R           |   54 ++++++++--------
 R/chemical.R         |  113 +++++++++++++++++-----------------
 R/chronology.R       |   14 ++--
 R/counts.R           |  167 +++++++++++++++++++++++----------------------------
 R/folio-internal.R   |only
 R/folio-package.R    |    2 
 R/isotopes.R         |  139 ++++++++++++++++++++++++++----------------
 README.md            |   38 ++++++++++-
 build/partial.rdb    |binary
 data/intcal09.rda    |binary
 data/kommos.rda      |binary
 data/nydal1996.rda   |binary
 data/vegetation.rda  |only
 data/verre.rda       |binary
 inst/CITATION        |   24 ++-----
 man/arnold1949.Rd    |   18 ++---
 man/birds.Rd         |    2 
 man/boves.Rd         |   17 -----
 man/chevelon.Rd      |   22 +++---
 man/compiegne.Rd     |   40 ++++++------
 man/epica2008.Rd     |    6 -
 man/folio-package.Rd |    3 
 man/intcal09.Rd      |   12 +--
 man/intcal13.Rd      |   12 +--
 man/intcal20.Rd      |   12 +--
 man/kommos.Rd        |   48 +++++++-------
 man/law2006.Rd       |   18 ++---
 man/lisiecki2005.Rd  |   11 +--
 man/loire.Rd         |   16 ++--
 man/merzbach.Rd      |    3 
 man/mississippi.Rd   |   22 +++---
 man/munsingen.Rd     |    2 
 man/ngrip2004.Rd     |    9 +-
 man/ngrip2010.Rd     |   13 ++-
 man/nydal1996.Rd     |   15 ++--
 man/shipwrecks.Rd    |   30 ++++-----
 man/spratt2016.Rd    |   45 +++++++------
 man/stratigraphy.Rd  |   14 ++--
 man/vegetation.Rd    |only
 man/verre.Rd         |   65 ++++++++++---------
 man/zuni.Rd          |   41 ++++++------
 45 files changed, 630 insertions(+), 589 deletions(-)

More information about folio at CRAN
Permanent link

Package fitODBODRshiny updated to version 1.0.1 with previous version 1.0.0 dated 2024-02-09

Title: 'Shiny' Application for R Package 'fitODBOD'
Description: For binomial outcome data Alternate Binomial Distributions and Binomial Mixture Distributions are fitted when overdispersion is available.
Author: Amalan Mahendran [cre, aut]
Maintainer: Amalan Mahendran <amalan0595@gmail.com>

Diff between fitODBODRshiny versions 1.0.0 dated 2024-02-09 and 1.0.1 dated 2024-02-26

 DESCRIPTION      |    8 ++++----
 MD5              |    6 +++---
 R/All_Plots.R    |    3 ++-
 man/All_Plots.Rd |    3 ++-
 4 files changed, 11 insertions(+), 9 deletions(-)

More information about fitODBODRshiny at CRAN
Permanent link

Package DImodelsVis updated to version 1.0.1 with previous version 1.0.0 dated 2024-02-19

Title: Visualising and Interpreting Statistical Models Fit to Compositional Data
Description: Statistical models fit to compositional data are often difficult to interpret due to the sum to 1 constraint on data variables. 'DImodelsVis' provides novel visualisations tools to aid with the interpretation of models fit to compositional data. All visualisations in the package are created using the 'ggplot2' plotting framework and can be extended like every other 'ggplot' object.
Author: Rishabh Vishwakarma [aut, cre] , Caroline Brophy [aut], Laura Byrne [aut], Catherine Hurley [aut]
Maintainer: Rishabh Vishwakarma <vishwakr@tcd.ie>

Diff between DImodelsVis versions 1.0.0 dated 2024-02-19 and 1.0.1 dated 2024-02-26

 DImodelsVis-1.0.0/DImodelsVis/man/figures/DImodelsVis_workflow_package.png  |only
 DImodelsVis-1.0.1/DImodelsVis/DESCRIPTION                                   |    6 
 DImodelsVis-1.0.1/DImodelsVis/MD5                                           |   58 +++----
 DImodelsVis-1.0.1/DImodelsVis/NEWS.md                                       |    5 
 DImodelsVis-1.0.1/DImodelsVis/R/ConditionalTernary.R                        |   14 +
 DImodelsVis-1.0.1/DImodelsVis/R/DImodelsVis-package.R                       |    8 -
 DImodelsVis-1.0.1/DImodelsVis/R/GradientChange.R                            |   59 +++++--
 DImodelsVis-1.0.1/DImodelsVis/R/GroupedTernary.R                            |   64 +-------
 DImodelsVis-1.0.1/DImodelsVis/R/ModelDiagnostics.R                          |   18 +-
 DImodelsVis-1.0.1/DImodelsVis/R/PredictionContributions.R                   |   23 +--
 DImodelsVis-1.0.1/DImodelsVis/R/SanityChecks.R                              |    6 
 DImodelsVis-1.0.1/DImodelsVis/R/SimplexPath.R                               |   47 +++---
 DImodelsVis-1.0.1/DImodelsVis/R/Ternary.R                                   |   37 ++---
 DImodelsVis-1.0.1/DImodelsVis/R/Utilities.R                                 |   13 -
 DImodelsVis-1.0.1/DImodelsVis/R/VisualiseEffects.R                          |   58 ++++---
 DImodelsVis-1.0.1/DImodelsVis/README.md                                     |   61 +-------
 DImodelsVis-1.0.1/DImodelsVis/inst/WORDLIST                                 |    1 
 DImodelsVis-1.0.1/DImodelsVis/inst/doc/DImodelsVis-with-complex-models.html |   74 ++++------
 DImodelsVis-1.0.1/DImodelsVis/man/DImodelsVis-package.Rd                    |    8 -
 DImodelsVis-1.0.1/DImodelsVis/man/figures/DImodelsVisWorkflowPackage.png    |only
 DImodelsVis-1.0.1/DImodelsVis/man/figures/README-cond-ternary-1.png         |binary
 DImodelsVis-1.0.1/DImodelsVis/man/figures/README-effects-plot-1.png         |binary
 DImodelsVis-1.0.1/DImodelsVis/man/figures/README-model-diagnostics-1.png    |binary
 DImodelsVis-1.0.1/DImodelsVis/man/figures/README-simplex-path-1.png         |binary
 DImodelsVis-1.0.1/DImodelsVis/man/gradient_change.Rd                        |    8 +
 DImodelsVis-1.0.1/DImodelsVis/man/gradient_change_plot.Rd                   |   27 ++-
 DImodelsVis-1.0.1/DImodelsVis/man/simplex_path.Rd                           |    4 
 DImodelsVis-1.0.1/DImodelsVis/man/simplex_path_plot.Rd                      |   19 +-
 DImodelsVis-1.0.1/DImodelsVis/man/ternary_plot.Rd                           |   23 +--
 DImodelsVis-1.0.1/DImodelsVis/man/visualise_effects.Rd                      |    4 
 DImodelsVis-1.0.1/DImodelsVis/man/visualise_effects_plot.Rd                 |   14 +
 31 files changed, 311 insertions(+), 348 deletions(-)

More information about DImodelsVis at CRAN
Permanent link

Package vvmover updated to version 1.6.0 with previous version 1.5.10 dated 2023-02-01

Title: Read and Write Data
Description: Offers a wide range of functions for reading and writing data in various file formats, including CSV, RDS, Excel and ZIP files. Additionally, it provides functions for retrieving metadata associated with files, such as file size and creation date, making it easy to manage and organize large data sets. This package is designed to simplify data import and export tasks, and provide users with a comprehensive set of tools to work with different types of data files.
Author: Tomer Iwan [aut, cre, cph]
Maintainer: Tomer Iwan <t.iwan@vu.nl>

Diff between vvmover versions 1.5.10 dated 2023-02-01 and 1.6.0 dated 2024-02-26

 DESCRIPTION                              |   12 ++-
 LICENSE                                  |    4 -
 MD5                                      |   54 ++++++++++-----
 NAMESPACE                                |   26 ++++---
 R/add_current_datetime_column.R          |only
 R/calculate_na_percentage.R              |only
 R/check_installed_package.R              |   58 +++++++++--------
 R/get_recent_file.R                      |   60 ++++++++---------
 R/get_recent_file_date_filename_ymd.R    |   61 ++++++++----------
 R/get_recent_file_date_modified.R        |  105 +++++++++++++++----------------
 R/is_field_subset.R                      |only
 R/move_files_pattern.R                   |   58 ++++++++---------
 R/print_last_modified.R                  |   11 +++
 R/random_string_vector.R                 |only
 R/read_excel_allsheet.R                  |   44 ++++++------
 R/save_session_info_to_file.R            |only
 R/unzip_read_delim.R                     |  105 +++++++++++++++----------------
 R/utils-pipe.R                           |only
 README.md                                |   91 +++++++++++++-------------
 man/add_current_datetime_column.Rd       |only
 man/calculate_na_percentage.Rd           |only
 man/check_installed_package.Rd           |   48 +++++++-------
 man/figures/hex-vvmover.png              |only
 man/get_last_modifed_date.Rd             |only
 man/get_recent_file.Rd                   |   62 +++++++++---------
 man/get_recent_file_date_filename_ymd.Rd |   54 +++++++--------
 man/get_recent_file_date_modified.Rd     |   68 ++++++++++----------
 man/is_field_subset.Rd                   |only
 man/move_files_pattern.Rd                |   46 ++++++-------
 man/pipe.Rd                              |only
 man/print_last_modified.Rd               |   42 ++++++------
 man/random_string_vector.Rd              |only
 man/read_excel_allsheets.Rd              |   42 ++++++------
 man/save_session_info_to_file.Rd         |only
 man/unzip_read_delim.Rd                  |   50 +++++++-------
 35 files changed, 571 insertions(+), 530 deletions(-)

More information about vvmover at CRAN
Permanent link

Package vvauditor updated to version 0.6.0 with previous version 0.5.8 dated 2023-02-01

Title: Creates Assertion Tests
Description: Offers a comprehensive set of assertion tests to help users validate the integrity of their data. These tests can be used to check for specific conditions or properties within a dataset and help ensure that data is accurate and reliable. The package is designed to make it easy to add quality control checks to data analysis workflows and to aid in identifying and correcting any errors or inconsistencies in data.
Author: Tomer Iwan [aut, cre, cph]
Maintainer: Tomer Iwan <t.iwan@vu.nl>

Diff between vvauditor versions 0.5.8 dated 2023-02-01 and 0.6.0 dated 2024-02-26

 DESCRIPTION                            |   12 ++-
 LICENSE                                |    4 -
 MD5                                    |  122 +++++++++++++++++++++++++--------
 NAMESPACE                              |   65 +++++++++++++----
 R/Check_rows.R                         |   37 ++++------
 R/Count_more_than_1.R                  |   32 ++++----
 R/Drop_NA_column_names.R               |   22 ++---
 R/assert_date_named.R                  |only
 R/assert_logical_named.R               |only
 R/assert_message.R                     |only
 R/assert_no_duplicates_in_group.R      |only
 R/check_double_columns.R               |   52 +++++++-------
 R/check_duplicates.R                   |only
 R/check_no_duplicate_rows.R            |only
 R/check_no_duplicates_in_group.R       |only
 R/check_numeric_or_integer_type.R      |only
 R/check_posixct_type.R                 |only
 R/create_dataset_summary_table.R       |only
 R/duplicates_in_column.R               |   63 ++++++++---------
 R/find_common_columns.R                |only
 R/find_pattern_r.R                     |   30 ++++----
 R/get_values.R                         |   50 ++++++-------
 R/identify_join_pairs.R                |only
 R/identify_outliers.R                  |only
 R/md_complete_cases.R                  |   48 ++++++------
 R/regex_content_parameter.R            |only
 R/regex_time.R                         |only
 R/regex_year_date.R                    |only
 R/remove_duplicates_and_na.R           |only
 R/retrieve_function_calls.R            |only
 R/retrieve_functions_and_packages.R    |   48 ++++++------
 R/retrieve_package_usage.R             |only
 R/retrieve_sourced_scripts.R           |only
 R/retrieve_string_assignments.R        |only
 R/return_assertions_message.R          |only
 R/str_detect_in_file.R                 |   70 +++++++++---------
 R/test_all_equal.R                     |   40 +++++-----
 R/unique_id.R                          |   58 +++++++--------
 README.md                              |   79 +++++++++++++--------
 build                                  |only
 inst                                   |only
 man/assert_date_named.Rd               |only
 man/assert_logical_named.Rd            |only
 man/assert_no_duplicates_in_group.Rd   |only
 man/assertion_message.Rd               |only
 man/calculate_category_percentages.Rd  |only
 man/check_double_columns.Rd            |   65 +++++++++--------
 man/check_duplicates.Rd                |only
 man/check_na_columns.Rd                |only
 man/check_no_duplicate_rows.Rd         |only
 man/check_no_duplicates_in_group.Rd    |only
 man/check_non_zero_rows.Rd             |only
 man/check_numeric_or_integer_type.Rd   |only
 man/check_posixct_type.Rd              |only
 man/check_rows.Rd                      |   49 ++++++-------
 man/check_zero_columns.Rd              |only
 man/count_more_than_1.Rd               |   48 ++++++------
 man/create_dataset_summary_table.Rd    |only
 man/drop_na_column_names.Rd            |   34 ++++-----
 man/duplicates_in_column.Rd            |   61 ++++++++--------
 man/figures                            |only
 man/find_common_columns.Rd             |only
 man/find_maximum_value.Rd              |only
 man/find_minimum_value.Rd              |only
 man/find_pattern_r.Rd                  |   46 ++++++------
 man/get_distribution_statistics.Rd     |only
 man/get_first_element_class.Rd         |only
 man/get_values.Rd                      |   47 ++++++------
 man/identify_join_pairs.Rd             |only
 man/identify_outliers.Rd               |only
 man/is_unique_column.Rd                |only
 man/md_complete_cases.Rd               |   54 +++++++-------
 man/regex_content_parameter.Rd         |only
 man/regex_time.Rd                      |only
 man/regex_year_date.Rd                 |only
 man/remove_duplicates_and_na.Rd        |only
 man/retrieve_function_calls.Rd         |only
 man/retrieve_functions_and_packages.Rd |   34 ++++-----
 man/retrieve_package_usage.Rd          |only
 man/retrieve_sourced_scripts.Rd        |only
 man/retrieve_string_assignments.Rd     |only
 man/return_assertions_message.Rd       |only
 man/str_detect_in_file.Rd              |   50 ++++++-------
 man/test_all_equal.Rd                  |   65 +++++++++--------
 man/unique_id.Rd                       |   56 +++++++--------
 tests                                  |only
 vignettes                              |only
 87 files changed, 785 insertions(+), 656 deletions(-)

More information about vvauditor at CRAN
Permanent link

Package vcfppR updated to version 0.4.0 with previous version 0.3.8 dated 2024-01-14

Title: Rapid Manipulation of the Variant Call Format (VCF)
Description: The 'vcfpp.h' (<https://github.com/Zilong-Li/vcfpp>) provides an easy-to-use 'C++' 'API' of 'htslib', offering full functionality for manipulating Variant Call Format (VCF) files. The 'vcfppR' package serves as the R bindings of the 'vcfpp.h' library, enabling rapid processing of both compressed and uncompressed VCF/BCF files. Explore a range of powerful features for efficient VCF data manipulation.
Author: Zilong Li [aut, cre] , Bonfield, James K and Marshall, John and Danecek, Petr and Li, Heng [cph]
Maintainer: Zilong Li <zilong.dk@gmail.com>

Diff between vcfppR versions 0.3.8 dated 2024-01-14 and 0.4.0 dated 2024-02-26

 DESCRIPTION                     |    8 ++++----
 MD5                             |   12 ++++++------
 NEWS.md                         |    5 +++++
 R/vcf-tables.R                  |    5 ++++-
 man/vcftable.Rd                 |    5 ++++-
 src/Makevars.win                |   11 ++++++++++-
 tests/testthat/test-vcf-table.R |    5 +++++
 7 files changed, 38 insertions(+), 13 deletions(-)

More information about vcfppR at CRAN
Permanent link

Package tweenr updated to version 2.0.3 with previous version 2.0.2 dated 2022-09-06

Title: Interpolate Data for Smooth Animations
Description: In order to create smooth animation between states of data, tweening is necessary. This package provides a range of functions for creating tweened data that can be used as basis for animation. Furthermore it adds a number of vectorized interpolaters for common R data types such as numeric, date and colour.
Author: Thomas Lin Pedersen [aut, cre]
Maintainer: Thomas Lin Pedersen <thomasp85@gmail.com>

Diff between tweenr versions 2.0.2 dated 2022-09-06 and 2.0.3 dated 2024-02-26

 DESCRIPTION          |    9 ++--
 MD5                  |   27 +++++++------
 NAMESPACE            |    1 
 NEWS.md              |    5 ++
 R/cpp11.R            |   48 +++++++++++++++++-------
 R/interpolate_at.R   |   55 ++++++++++++++++++++++++++++
 R/tween_along.R      |    6 ++-
 R/tween_at.R         |   91 ++++++++++++++++++++++++++++++++++++++++++++++
 R/tween_components.R |    2 -
 R/tween_fill.R       |    2 -
 R/tween_state.R      |   64 +++++++++++++++++++++-----------
 R/tween_states.R     |    2 -
 man/tween_at_t.Rd    |only
 src/at.cpp           |   99 +++++++++++++++++++++++++++++++++++++++++++++++++++
 src/cpp11.cpp        |   94 ++++++++++++++++++++++++++++++++++--------------
 15 files changed, 419 insertions(+), 86 deletions(-)

More information about tweenr at CRAN
Permanent link

Package plotmo updated to version 3.6.3 with previous version 3.6.2 dated 2022-05-21

Title: Plot a Model's Residuals, Response, and Partial Dependence Plots
Description: Plot model surfaces for a wide variety of models using partial dependence plots and other techniques. Also plot model residuals and other information on the model.
Author: Stephen Milborrow
Maintainer: Stephen Milborrow <milbo@sonic.net>

Diff between plotmo versions 3.6.2 dated 2022-05-21 and 3.6.3 dated 2024-02-26

 plotmo-3.6.2/plotmo/NEWS                                       |only
 plotmo-3.6.3/plotmo/DESCRIPTION                                |    8 
 plotmo-3.6.3/plotmo/MD5                                        |  150 +++----
 plotmo-3.6.3/plotmo/NAMESPACE                                  |  105 ++++
 plotmo-3.6.3/plotmo/NEWS.md                                    |only
 plotmo-3.6.3/plotmo/R/as.char.R                                |    8 
 plotmo-3.6.3/plotmo/R/gbm.R                                    |    8 
 plotmo-3.6.3/plotmo/R/gbm.backcompat.R                         |    4 
 plotmo-3.6.3/plotmo/R/grid.R                                   |    2 
 plotmo-3.6.3/plotmo/R/lib.R                                    |    2 
 plotmo-3.6.3/plotmo/R/plot_gbm.R                               |    3 
 plotmo-3.6.3/plotmo/R/plot_glmnet.R                            |    3 
 plotmo-3.6.3/plotmo/R/plotcum.R                                |    3 
 plotmo-3.6.3/plotmo/R/plotmo.R                                 |   28 -
 plotmo-3.6.3/plotmo/R/plotresids.R                             |    2 
 plotmo-3.6.3/plotmo/R/response.R                               |    4 
 plotmo-3.6.3/plotmo/R/singles.R                                |    6 
 plotmo-3.6.3/plotmo/R/spread.labs.R                            |only
 plotmo-3.6.3/plotmo/R/w1.R                                     |    8 
 plotmo-3.6.3/plotmo/R/xy.R                                     |   24 -
 plotmo-3.6.3/plotmo/inst/slowtests/make.README.bat             |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/make.bat                    |   56 +-
 plotmo-3.6.3/plotmo/inst/slowtests/makeclean.bat               |    6 
 plotmo-3.6.3/plotmo/inst/slowtests/test.c50.Rout.save          |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.c50.bat                |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.caret.Rout.save        |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.caret.bat              |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.center.Rout.save       |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.center.bat             |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.degree.Rout.save       |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.degree.bat             |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.dots.Rout.save         |    5 
 plotmo-3.6.3/plotmo/inst/slowtests/test.dots.bat               |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.fac.Rout.save          |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.fac.bat                |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.gbm.Rout.save          |    4 
 plotmo-3.6.3/plotmo/inst/slowtests/test.gbm.bat                |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.glmnet.Rout.save       |    3 
 plotmo-3.6.3/plotmo/inst/slowtests/test.glmnet.bat             |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.glmnetUtils.Rout.save  |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.glmnetUtils.bat        |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.linmod.Rout.save       |    7 
 plotmo-3.6.3/plotmo/inst/slowtests/test.linmod.bat             |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.mlr.Rout.save          |   18 
 plotmo-3.6.3/plotmo/inst/slowtests/test.mlr.bat                |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.modguide.Rout.save     |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.modguide.bat           |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.non.earth.Rout.save    |   15 
 plotmo-3.6.3/plotmo/inst/slowtests/test.non.earth.bat          |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.parsnip.R              |   12 
 plotmo-3.6.3/plotmo/inst/slowtests/test.parsnip.Rout.save      |  211 ++++------
 plotmo-3.6.3/plotmo/inst/slowtests/test.parsnip.bat            |    9 
 plotmo-3.6.3/plotmo/inst/slowtests/test.partdep.Rout.save      |    6 
 plotmo-3.6.3/plotmo/inst/slowtests/test.partdep.bat            |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.partykit.Rout.save     |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.partykit.bat           |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo.Rout.save       |    5 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo.args.Rout.save  |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo.args.bat        |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo.bat             |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo.dots.R          |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo.dots.Rout.save  |    3 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo.dots.bat        |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo.x.Rout.save     |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo.x.bat           |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo3.Rout.save      |    6 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotmo3.bat            |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotres.Rout.save      |    5 
 plotmo-3.6.3/plotmo/inst/slowtests/test.plotres.bat            |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.pre.Rout.save          |    8 
 plotmo-3.6.3/plotmo/inst/slowtests/test.pre.bat                |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.printcall.Rout.save    |    1 
 plotmo-3.6.3/plotmo/inst/slowtests/test.printcall.bat          |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/test.unusual.vars.Rout.save |   13 
 plotmo-3.6.3/plotmo/inst/slowtests/test.unusual.vars.bat       |    2 
 plotmo-3.6.3/plotmo/inst/slowtests/x1                          |only
 plotmo-3.6.3/plotmo/man/plot_glmnet.Rd                         |    3 
 plotmo-3.6.3/plotmo/tests/test.plotmo.Rout.save                |    1 
 78 files changed, 444 insertions(+), 383 deletions(-)

More information about plotmo at CRAN
Permanent link

Package netmap updated to version 0.1.4 with previous version 0.1.3 dated 2024-02-13

Title: Represent Network Objects on a Map
Description: Represent 'network' or 'igraph' objects whose vertices can be represented by features in an 'sf' object as a network graph surmising a 'sf' plot. Fits into 'ggplot2' grammar.
Author: Matteo Dimai [aut, cre]
Maintainer: Matteo Dimai <matteo.dimai@phd.units.it>

Diff between netmap versions 0.1.3 dated 2024-02-13 and 0.1.4 dated 2024-02-26

 DESCRIPTION          |    6 +++---
 MD5                  |    6 +++---
 NEWS.md              |   32 ++++++++++++++++++--------------
 R/link_network_map.R |    2 +-
 4 files changed, 25 insertions(+), 21 deletions(-)

More information about netmap at CRAN
Permanent link

Package mFD updated to version 1.0.7 with previous version 1.0.6 dated 2023-11-02

Title: Compute and Illustrate the Multiple Facets of Functional Diversity
Description: Computing functional traits-based distances between pairs of species for species gathered in assemblages allowing to build several functional spaces. The package allows to compute functional diversity indices assessing the distribution of species (and of their dominance) in a given functional space for each assemblage and the overlap between assemblages in a given functional space, see: Chao et al. (2018) <doi:10.1002/ecm.1343>, Maire et al. (2015) <doi:10.1111/geb.12299>, Mouillot et al. (2013) <doi:10.1016/j.tree.2012.10.004>, Mouillot et al. (2014) <doi:10.1073/pnas.1317625111>, Ricotta and Szeidl (2009) <doi:10.1016/j.tpb.2009.10.001>. Graphical outputs are included. Visit the 'mFD' website for more information, documentation and examples.
Author: Camille Magneville [aut, cre, cph] , Nicolas Loiseau [aut] , Camille Albouy [aut] , Nicolas Casajus [aut] , Thomas Claverie [aut] , Arthur Escalas [aut] , Fabien Leprieur [aut] , Eva Maire [aut] , David Mouillot [aut] , Sebastien Villeger [aut]
Maintainer: Camille Magneville <camille.magneville@gmail.com>

Diff between mFD versions 1.0.6 dated 2023-11-02 and 1.0.7 dated 2024-02-26

 DESCRIPTION                                                      |    6 +-
 MD5                                                              |   22 +++++-----
 NEWS.md                                                          |    5 ++
 R/check_inputs.R                                                 |    5 +-
 inst/doc/Compute_and_interpret_quality_of_functional_spaces.html |    4 -
 inst/doc/Compute_functional_hill_indices.html                    |    4 -
 inst/doc/Continuous_traits_framework.html                        |    4 -
 inst/doc/Customised_plots.html                                   |    4 -
 inst/doc/How_to_deal_with_Functional_Entities.html               |    4 -
 inst/doc/mFD_general_workflow.Rmd                                |   15 +++---
 inst/doc/mFD_general_workflow.html                               |   16 ++++---
 vignettes/mFD_general_workflow.Rmd                               |   15 +++---
 12 files changed, 56 insertions(+), 48 deletions(-)

More information about mFD at CRAN
Permanent link

Package itdr updated to version 2.0.1 with previous version 2.0.0 dated 2023-06-23

Title: Integral Transformation Methods for SDR in Regression
Description: The itdr() routine allows for the estimation of sufficient dimension reduction subspaces in univariate regression such as the central mean subspace or central subspace in regression. This is achieved using Fourier transformation methods proposed by Zhu and Zeng (2006) <doi:10.1198/016214506000000140>, convolution transformation methods proposed by Zeng and Zhu (2010) <doi:10.1016/j.jmva.2009.08.004>, and iterative Hessian transformation methods proposed by Cook and Li (2002) <doi:10.1214/aos/1021379861>. Additionally, mitdr() function provides optimal estimators for sufficient dimension reduction subspaces in multivariate regression by optimizing a discrepancy function using a Fourier transform approach proposed by Weng and Yin (2022) <doi:10.5705/ss.202020.0312>, and selects the sufficient variables using Fourier transform sparse inverse regression estimators proposed by Weng (2022) <doi:10.1016/j.csda.2021.107380>.
Author: Tharindu P. De Alwis [aut, cre] , S. Yaser Samadi [ctb, aut] , Jiaying Weng [ctb, aut]
Maintainer: Tharindu P. De Alwis <talwis@wpi.edu>

Diff between itdr versions 2.0.0 dated 2023-06-23 and 2.0.1 dated 2024-02-26

 itdr-2.0.0/itdr/R/IntTrans.R                |only
 itdr-2.0.0/itdr/R/PDB.R                     |only
 itdr-2.0.0/itdr/R/Raman.R                   |only
 itdr-2.0.0/itdr/R/Recumbent.R               |only
 itdr-2.0.0/itdr/R/fm_xire.R                 |only
 itdr-2.0.0/itdr/R/iht.R                     |only
 itdr-2.0.0/itdr/R/invFM.R                   |only
 itdr-2.0.0/itdr/data/PDB.RData              |only
 itdr-2.0.0/itdr/man/PDB.Rd                  |only
 itdr-2.0.0/itdr/man/Raman.Rd                |only
 itdr-2.0.0/itdr/man/Recumbent.Rd            |only
 itdr-2.0.0/itdr/man/admmft.Rd               |only
 itdr-2.0.0/itdr/man/fm_xire.Rd              |only
 itdr-2.0.0/itdr/man/invFM.Rd                |only
 itdr-2.0.0/itdr/man/wh.Rd                   |only
 itdr-2.0.0/itdr/man/wx.Rd                   |only
 itdr-2.0.0/itdr/man/wy.Rd                   |only
 itdr-2.0.1/itdr/DESCRIPTION                 |   10 
 itdr-2.0.1/itdr/MD5                         |   94 -
 itdr-2.0.1/itdr/NAMESPACE                   |    8 
 itdr-2.0.1/itdr/NEWS.md                     |   60 
 itdr-2.0.1/itdr/R/ConvolutionMethod.R       |only
 itdr-2.0.1/itdr/R/FTIRE.R                   | 1761 +++++++++++----------
 itdr-2.0.1/itdr/R/FourierMethod-XIRE.R      |only
 itdr-2.0.1/itdr/R/FourierMethod.R           |  178 +-
 itdr-2.0.1/itdr/R/InverseFourierMethod.R    |only
 itdr-2.0.1/itdr/R/IterativeHessionTr.R      |only
 itdr-2.0.1/itdr/R/admmft.R                  |  192 --
 itdr-2.0.1/itdr/R/admmft_Methods.R          |  181 +-
 itdr-2.0.1/itdr/R/automobile.R              |   40 
 itdr-2.0.1/itdr/R/cvft.R                    |  126 -
 itdr-2.0.1/itdr/R/d.boost.R                 |  130 -
 itdr-2.0.1/itdr/R/d.test.R                  |  304 +--
 itdr-2.0.1/itdr/R/dsp.R                     |   46 
 itdr-2.0.1/itdr/R/hyperPara.R               |only
 itdr-2.0.1/itdr/R/itdr.R                    |  166 +-
 itdr-2.0.1/itdr/R/mitdr.R                   |only
 itdr-2.0.1/itdr/R/pdb.R                     |only
 itdr-2.0.1/itdr/R/prostate.R                |   20 
 itdr-2.0.1/itdr/R/raman.R                   |only
 itdr-2.0.1/itdr/R/recumbent.R               |only
 itdr-2.0.1/itdr/R/wh.R                      |  102 -
 itdr-2.0.1/itdr/R/wx.R                      |  113 -
 itdr-2.0.1/itdr/R/wy.R                      |  100 -
 itdr-2.0.1/itdr/build/vignette.rds          |binary
 itdr-2.0.1/itdr/data/pdb.RData              |only
 itdr-2.0.1/itdr/data/raman.RData            |binary
 itdr-2.0.1/itdr/data/recumbent.RData        |binary
 itdr-2.0.1/itdr/inst/CITATION               |   12 
 itdr-2.0.1/itdr/inst/doc/itdr-vignette.R    |  252 +--
 itdr-2.0.1/itdr/inst/doc/itdr-vignette.Rmd  |  577 +++----
 itdr-2.0.1/itdr/inst/doc/itdr-vignette.html | 2294 ++++++++++++++--------------
 itdr-2.0.1/itdr/man/automobile.Rd           |   36 
 itdr-2.0.1/itdr/man/d.boots.Rd              |   39 
 itdr-2.0.1/itdr/man/d.test.Rd               |   55 
 itdr-2.0.1/itdr/man/dsp.Rd                  |   20 
 itdr-2.0.1/itdr/man/hyperPara.Rd            |only
 itdr-2.0.1/itdr/man/itdr.Rd                 |  112 -
 itdr-2.0.1/itdr/man/mitdr.Rd                |only
 itdr-2.0.1/itdr/man/pdb.Rd                  |only
 itdr-2.0.1/itdr/man/prostate.Rd             |   10 
 itdr-2.0.1/itdr/man/raman.Rd                |only
 itdr-2.0.1/itdr/man/recumbent.Rd            |only
 itdr-2.0.1/itdr/vignettes/itdr-vignette.Rmd |  577 +++----
 64 files changed, 3847 insertions(+), 3768 deletions(-)

More information about itdr at CRAN
Permanent link

Package EpiForsk updated to version 0.1.1 with previous version 0.0.1 dated 2023-02-10

Title: Code Sharing at the Department of Epidemiological Research at Statens Serum Institut
Description: This is a collection of assorted functions and examples collected from various projects. Currently we have functionalities for simplifying overlapping time intervals, Charlson comorbidity score constructors for Danish data, getting frequency for multiple variables, getting standardized output from logistic and log-linear regressions, sibling design linear regression functionalities a method for calculating the confidence intervals for functions of parameters from a GLM, Bayes equivalent for hypothesis testing with asymptotic Bayes factor, and several help functions for generalized random forest analysis using 'grf'.
Author: Anders Husby [aut] , Anna Laksafoss [aut] , Emilia Myrup Thiesson [aut] , Kim Daniel Jakobsen [aut, cre] , Mikael Andersson [aut] , Klaus Rostgaard [aut]
Maintainer: Kim Daniel Jakobsen <kija@ssi.dk>

Diff between EpiForsk versions 0.0.1 dated 2023-02-10 and 0.1.1 dated 2024-02-26

 DESCRIPTION                              |   49 
 LICENSE                                  |    4 
 MD5                                      |   97 +
 NAMESPACE                                |   32 
 R/EpiForsk_package.R                     |   85 -
 R/adls_braid_rows.R                      |  176 +-
 R/adls_flatten_date_intervals.R          |  363 ++---
 R/adls_try_catch_warnings.R              |only
 R/aso_charlson_score.R                   | 1475 ++++++++-------------
 R/aso_freq_function.R                    |only
 R/aso_freq_function_repeated.R           |only
 R/aso_many_merge.R                       |only
 R/aso_odds_ratio_function.R              |only
 R/aso_odds_ratio_function_repeated.R     |only
 R/data.R                                 |   80 -
 R/kija_c_for_benefit.R                   |only
 R/kija_cate_surface.R                    |only
 R/kija_causal_forest_dynamic_subgroups.R |only
 R/kija_covariate_balance.R               |only
 R/kija_discrete_covariate_names.R        |only
 R/kija_discrete_covariates_to_onehot.R   |only
 R/kija_fct_confint.R                     | 2079 ++++++++++++++++++++-----------
 R/kija_lms.R                             |  382 ++---
 R/kija_multi_join.R                      |only
 R/kija_rate_omnibus_test.R               |only
 R/kija_rate_test.R                       |only
 R/kija_vcovHC.R                          |only
 R/klp_AsympBF.R                          |only
 README.md                                |   11 
 build/vignette.rds                       |binary
 inst/doc/Contributing.html               |  119 -
 inst/doc/Writing_functions.Rmd           |  124 -
 inst/doc/Writing_functions.html          |   14 
 inst/doc/andh_forest_plot.R              |    4 
 inst/doc/andh_forest_plot.Rmd            |  500 +++----
 inst/doc/andh_forest_plot.html           |  509 +++----
 man/CATESurface.Rd                       |only
 man/CForBenefit.Rd                       |only
 man/CausalForestDynamicSubgroups.Rd      |only
 man/CovariateBalance.Rd                  |only
 man/DiscreteCovariateNames.Rd            |only
 man/DiscreteCovariatesToOneHot.Rd        |only
 man/EpiForsk-package.Rd                  |   32 
 man/RATEOmnibusTest.Rd                   |only
 man/RATETest.Rd                          |only
 man/asympBF.Rd                           |only
 man/braid_rows.Rd                        |  112 -
 man/ceiling_dec.Rd                       |only
 man/charlson_score.Rd                    |  346 ++---
 man/ci_fct.Rd                            |only
 man/ci_fct_error_handler.Rd              |only
 man/decimalplaces.Rd                     |only
 man/dot-datatable.aware.Rd               |only
 man/fct_confint.Rd                       |  104 -
 man/figures                              |only
 man/floor_dec.Rd                         |only
 man/freq_function.Rd                     |only
 man/freq_function_repeated.Rd            |only
 man/lms.Rd                               |    2 
 man/many_merge.Rd                        |only
 man/multi_join.Rd                        |only
 man/odds_ratio_function.Rd               |only
 man/odds_ratio_function_repeated.Rd      |only
 man/summary.svy_vglm.Rd                  |only
 man/try_catch_warnings.Rd                |only
 man/vcovHC.Rd                            |only
 tests/testthat.R                         |   24 
 tests/testthat/test-adls_braid_rows.R    |  170 +-
 vignettes/Writing_functions.Rmd          |  124 -
 vignettes/andh_forest_plot.Rmd           |  500 +++----
 70 files changed, 3980 insertions(+), 3537 deletions(-)

More information about EpiForsk at CRAN
Permanent link

Package earth updated to version 5.3.3 with previous version 5.3.2 dated 2023-01-26

Title: Multivariate Adaptive Regression Splines
Description: Build regression models using the techniques in Friedman's papers "Fast MARS" and "Multivariate Adaptive Regression Splines" <doi:10.1214/aos/1176347963>. (The term "MARS" is trademarked and thus not used in the name of the package.)
Author: Stephen Milborrow. Derived from mda:mars by Trevor Hastie and Rob Tibshirani. Uses Alan Miller's Fortran utilities with Thomas Lumley's leaps wrapper.
Maintainer: Stephen Milborrow <milbo@sonic.net>

Diff between earth versions 5.3.2 dated 2023-01-26 and 5.3.3 dated 2024-02-26

 earth-5.3.2/earth/inst/slowtests/test.earthmain.gcc64.bat           |only
 earth-5.3.3/earth/DESCRIPTION                                       |    7 
 earth-5.3.3/earth/MD5                                               |  158 +++---
 earth-5.3.3/earth/NAMESPACE                                         |    2 
 earth-5.3.3/earth/NEWS.md                                           |   10 
 earth-5.3.3/earth/R/bpairs.R                                        |    6 
 earth-5.3.3/earth/R/do.par.R                                        |    4 
 earth-5.3.3/earth/R/earth.R                                         |   12 
 earth-5.3.3/earth/R/earth.cv.R                                      |    6 
 earth-5.3.3/earth/R/earth.cv.lib.R                                  |    2 
 earth-5.3.3/earth/R/earth.fit.R                                     |   20 
 earth-5.3.3/earth/R/earth.glm.R                                     |    6 
 earth-5.3.3/earth/R/earth.regress.R                                 |    6 
 earth-5.3.3/earth/R/format.earth.R                                  |    6 
 earth-5.3.3/earth/R/lib.R                                           |    2 
 earth-5.3.3/earth/R/mars.to.earth.R                                 |    2 
 earth-5.3.3/earth/R/plot.earth.R                                    |    2 
 earth-5.3.3/earth/R/spread.labs.R                                   |only
 earth-5.3.3/earth/R/varmod.R                                        |   44 -
 earth-5.3.3/earth/build/partial.rdb                                 |binary
 earth-5.3.3/earth/inst/slowtests/check.earth.matches.glm.R          |   38 -
 earth-5.3.3/earth/inst/slowtests/earth.times.bat                    |    2 
 earth-5.3.3/earth/inst/slowtests/make.bat                           |   22 
 earth-5.3.3/earth/inst/slowtests/test.allowedfunc.Rout.save         |    1 
 earth-5.3.3/earth/inst/slowtests/test.allowedfunc.bat               |    2 
 earth-5.3.3/earth/inst/slowtests/test.big.Rout.save                 |    1 
 earth-5.3.3/earth/inst/slowtests/test.big.bat                       |    2 
 earth-5.3.3/earth/inst/slowtests/test.bpairs.R                      |   16 
 earth-5.3.3/earth/inst/slowtests/test.bpairs.Rout.save              |   49 -
 earth-5.3.3/earth/inst/slowtests/test.bpairs.bat                    |    2 
 earth-5.3.3/earth/inst/slowtests/test.cv.R                          |   88 +--
 earth-5.3.3/earth/inst/slowtests/test.cv.Rout.save                  |  117 ++--
 earth-5.3.3/earth/inst/slowtests/test.cv.bat                        |    2 
 earth-5.3.3/earth/inst/slowtests/test.earthc.gcc.bat                |   54 --
 earth-5.3.3/earth/inst/slowtests/test.earthc.gcc.out.save           |only
 earth-5.3.3/earth/inst/slowtests/test.earthc.msc.mak                |    2 
 earth-5.3.3/earth/inst/slowtests/test.earthc.out.save               |    4 
 earth-5.3.3/earth/inst/slowtests/test.earthmain.gcc.bat             |   70 +-
 earth-5.3.3/earth/inst/slowtests/test.earthmain.gcc.out.save        |only
 earth-5.3.3/earth/inst/slowtests/test.earthmain.msc.bat             |    4 
 earth-5.3.3/earth/inst/slowtests/test.emma.Rout                     |only
 earth-5.3.3/earth/inst/slowtests/test.emma.Rout.save                |    1 
 earth-5.3.3/earth/inst/slowtests/test.emma.bat                      |    2 
 earth-5.3.3/earth/inst/slowtests/test.expand.bpairs.Rout.save       |    4 
 earth-5.3.3/earth/inst/slowtests/test.expand.bpairs.bat             |    2 
 earth-5.3.3/earth/inst/slowtests/test.full.R                        |   33 -
 earth-5.3.3/earth/inst/slowtests/test.full.Rout.save                |   60 +-
 earth-5.3.3/earth/inst/slowtests/test.full.bat                      |    2 
 earth-5.3.3/earth/inst/slowtests/test.glm.Rout.save                 |  251 ++++-----
 earth-5.3.3/earth/inst/slowtests/test.glm.bat                       |    2 
 earth-5.3.3/earth/inst/slowtests/test.incorrect.Rout.save           |    1 
 earth-5.3.3/earth/inst/slowtests/test.incorrect.bat                 |    2 
 earth-5.3.3/earth/inst/slowtests/test.mem.Rout                      |only
 earth-5.3.3/earth/inst/slowtests/test.mem.Rout.save                 |    1 
 earth-5.3.3/earth/inst/slowtests/test.mem.bat                       |    2 
 earth-5.3.3/earth/inst/slowtests/test.mods.Rout.save                |    3 
 earth-5.3.3/earth/inst/slowtests/test.mods.bat                      |    2 
 earth-5.3.3/earth/inst/slowtests/test.multresp.Rout.save            |    1 
 earth-5.3.3/earth/inst/slowtests/test.multresp.bat                  |    2 
 earth-5.3.3/earth/inst/slowtests/test.numstab-mfpmath-387.Rout.save |    1 
 earth-5.3.3/earth/inst/slowtests/test.numstab.Rout.save             |  255 ++++------
 earth-5.3.3/earth/inst/slowtests/test.numstab.bat                   |    2 
 earth-5.3.3/earth/inst/slowtests/test.offset.R                      |   54 --
 earth-5.3.3/earth/inst/slowtests/test.offset.Rout.save              |   55 --
 earth-5.3.3/earth/inst/slowtests/test.offset.bat                    |    2 
 earth-5.3.3/earth/inst/slowtests/test.ordinal.Rout.save             |    1 
 earth-5.3.3/earth/inst/slowtests/test.ordinal.bat                   |    2 
 earth-5.3.3/earth/inst/slowtests/test.plotd.Rout.save               |    1 
 earth-5.3.3/earth/inst/slowtests/test.plotd.bat                     |    2 
 earth-5.3.3/earth/inst/slowtests/test.pmethod.cv.Rout.save          |    1 
 earth-5.3.3/earth/inst/slowtests/test.pmethod.cv.bat                |    2 
 earth-5.3.3/earth/inst/slowtests/test.varmod.Rout.save              |   77 +--
 earth-5.3.3/earth/inst/slowtests/test.varmod.bat                    |    2 
 earth-5.3.3/earth/inst/slowtests/test.varmod.mgcv.Rout.save         |   31 -
 earth-5.3.3/earth/inst/slowtests/test.varmod.mgcv.bat               |    2 
 earth-5.3.3/earth/inst/slowtests/test.weights.Rout.save             |   13 
 earth-5.3.3/earth/inst/slowtests/test.weights.bat                   |    2 
 earth-5.3.3/earth/man/earth.Rd                                      |    5 
 earth-5.3.3/earth/man/plot.earth.Rd                                 |    5 
 earth-5.3.3/earth/man/varmod.Rd                                     |   15 
 earth-5.3.3/earth/src/earth.c                                       |    5 
 earth-5.3.3/earth/src/leaps.f                                       |    4 
 earth-5.3.3/earth/tests/test.earth.Rout.save                        |    1 
 83 files changed, 796 insertions(+), 886 deletions(-)

More information about earth at CRAN
Permanent link

Package goeveg updated to version 0.7.4 with previous version 0.7.2 dated 2024-02-06

Title: Functions for Community Data and Ordinations
Description: A collection of functions useful in (vegetation) community analyses and ordinations. Includes automatic species selection for ordination diagrams, NMDS stress/scree plots, species response curves, merging of taxa as well as calculation and sorting of synoptic tables.
Author: Friedemann von Lampe [aut, cre], Jenny Schellenberg [aut]
Maintainer: Friedemann von Lampe <fvonlampe@uni-goettingen.de>

Diff between goeveg versions 0.7.2 dated 2024-02-06 and 0.7.4 dated 2024-02-26

 DESCRIPTION         |    8 -
 MD5                 |   26 ++--
 NAMESPACE           |    2 
 NEWS.md             |   15 ++
 R/clean_matrix.R    |only
 R/cov2per.R         |  317 +++++++++++++++++++++++++++++++++++-----------------
 R/merge_taxa.R      |  315 ++++++++++++++++-----------------------------------
 R/scale_tabs.r      |    6 
 R/syntable.R        |    9 -
 R/trans_matrix.R    |only
 README.md           |    1 
 man/clean_matrix.Rd |only
 man/cov2per.Rd      |    6 
 man/merge_taxa.Rd   |   11 +
 man/scale_tabs.Rd   |    6 
 man/trans_matrix.Rd |only
 16 files changed, 378 insertions(+), 344 deletions(-)

More information about goeveg at CRAN
Permanent link

Package photobiology updated to version 0.11.1 with previous version 0.11.0 dated 2023-10-20

Title: Photobiological Calculations
Description: Definitions of classes, methods, operators and functions for use in photobiology and radiation meteorology and climatology. Calculation of effective (weighted) and not-weighted irradiances/doses, fluence rates, transmittance, reflectance, absorptance, absorbance and diverse ratios and other derived quantities from spectral data. Local maxima and minima: peaks, valleys and spikes. Conversion between energy-and photon-based units. Wavelength interpolation. Astronomical calculations related solar angles and day length. Colours and vision. This package is part of the 'r4photobiology' suite, Aphalo, P. J. (2015) <doi:10.19232/uv4pb.2015.1.14>.
Author: Pedro J. Aphalo [aut, cre] , Titta K. Kotilainen [ctb] , Glenn Davis [ctb], Agnese Fazio [ctb]
Maintainer: Pedro J. Aphalo <pedro.aphalo@helsinki.fi>

Diff between photobiology versions 0.11.0 dated 2023-10-20 and 0.11.1 dated 2024-02-26

 photobiology-0.11.0/photobiology/data/clear.spct.rda                        |only
 photobiology-0.11.0/photobiology/data/opaque.spct.rda                       |only
 photobiology-0.11.0/photobiology/data/polyester.spct.rda                    |only
 photobiology-0.11.0/photobiology/data/sun.daily.data.rda                    |only
 photobiology-0.11.0/photobiology/data/sun.daily.spct.rda                    |only
 photobiology-0.11.0/photobiology/data/sun.spct.rda                          |only
 photobiology-0.11.0/photobiology/data/yellow.gel.rda                        |only
 photobiology-0.11.0/photobiology/man/D2.UV586.Rd                            |only
 photobiology-0.11.0/photobiology/man/D2.UV654.Rd                            |only
 photobiology-0.11.0/photobiology/man/FEL.BN.9101.165.Rd                     |only
 photobiology-0.11.0/photobiology/man/Ler_leaf_rflt.spct.Rd                  |only
 photobiology-0.11.0/photobiology/man/Ler_leaf_trns.spct.Rd                  |only
 photobiology-0.11.0/photobiology/man/Ler_leaf_trns_i.spct.Rd                |only
 photobiology-0.11.0/photobiology/man/clear_body.spct.Rd                     |only
 photobiology-0.11.0/photobiology/man/getBSWFUsed.Rd                         |only
 photobiology-0.11.0/photobiology/man/getResponseType.Rd                     |only
 photobiology-0.11.0/photobiology/man/getRfrType.Rd                          |only
 photobiology-0.11.0/photobiology/man/getTfrType.Rd                          |only
 photobiology-0.11.0/photobiology/man/opaque.spct.Rd                         |only
 photobiology-0.11.0/photobiology/man/polyester.spct.Rd                      |only
 photobiology-0.11.0/photobiology/man/sun.daily.data.Rd                      |only
 photobiology-0.11.0/photobiology/man/sun.daily.spct.Rd                      |only
 photobiology-0.11.0/photobiology/man/sun.data.Rd                            |only
 photobiology-0.11.0/photobiology/man/white_body.spct.Rd                     |only
 photobiology-0.11.0/photobiology/man/white_led.cps_spct.Rd                  |only
 photobiology-0.11.0/photobiology/man/white_led.raw_spct.Rd                  |only
 photobiology-0.11.0/photobiology/man/yellow_gel.spct.Rd                     |only
 photobiology-0.11.1/photobiology/DESCRIPTION                                |   10 
 photobiology-0.11.1/photobiology/MD5                                        |  262 -
 photobiology-0.11.1/photobiology/NAMESPACE                                  |    1 
 photobiology-0.11.1/photobiology/NEWS.md                                    |   63 
 photobiology-0.11.1/photobiology/R/copy.attr.R                              |   78 
 photobiology-0.11.1/photobiology/R/d2.fel.data.r                            |   45 
 photobiology-0.11.1/photobiology/R/filter.data.r                            |   67 
 photobiology-0.11.1/photobiology/R/insert.hinges.r                          |   64 
 photobiology-0.11.1/photobiology/R/leaf.data.R                              |   67 
 photobiology-0.11.1/photobiology/R/led.data.R                               |   52 
 photobiology-0.11.1/photobiology/R/mspct.sample.R                           |   15 
 photobiology-0.11.1/photobiology/R/object.data.r                            |   36 
 photobiology-0.11.1/photobiology/R/rbindspct.r                              |  269 -
 photobiology-0.11.1/photobiology/R/source-spct-ratios.R                     |  138 
 photobiology-0.11.1/photobiology/R/spct.classes.r                           |  363 +
 photobiology-0.11.1/photobiology/R/spct.conversion.R                        |    3 
 photobiology-0.11.1/photobiology/R/spct.fscale.r                            |  131 
 photobiology-0.11.1/photobiology/R/spct.irrad.r                             |  192 
 photobiology-0.11.1/photobiology/R/spct.metadata.r                          |   31 
 photobiology-0.11.1/photobiology/R/spct.normalize.r                         |  280 -
 photobiology-0.11.1/photobiology/R/spct.operators.r                         |  209 
 photobiology-0.11.1/photobiology/R/spct.peaks.r                             |  457 +-
 photobiology-0.11.1/photobiology/R/spct.smooth.spct.r                       |  104 
 photobiology-0.11.1/photobiology/R/spct.spikes.R                            |  275 -
 photobiology-0.11.1/photobiology/R/spct.trim.r                              |    7 
 photobiology-0.11.1/photobiology/R/spct.utils.r                             |   51 
 photobiology-0.11.1/photobiology/R/sun.data.r                               |   84 
 photobiology-0.11.1/photobiology/R/zmspct.classes.R                         |   15 
 photobiology-0.11.1/photobiology/README.md                                  |   22 
 photobiology-0.11.1/photobiology/data/filter-data.rda                       |only
 photobiology-0.11.1/photobiology/data/sun.data.rda                          |binary
 photobiology-0.11.1/photobiology/data/white-led-spct.rda                    |binary
 photobiology-0.11.1/photobiology/inst/doc/userguide-0-r4p-introduction.html |    2 
 photobiology-0.11.1/photobiology/inst/doc/userguide-1-radiation.R           |  124 
 photobiology-0.11.1/photobiology/inst/doc/userguide-1-radiation.Rmd         |  183 
 photobiology-0.11.1/photobiology/inst/doc/userguide-1-radiation.html        | 2161 +++++-----
 photobiology-0.11.1/photobiology/inst/doc/userguide-2-astronomy.html        |   48 
 photobiology-0.11.1/photobiology/man/A.illuminant.spct.Rd                   |   18 
 photobiology-0.11.1/photobiology/man/A2T.Rd                                 |    4 
 photobiology-0.11.1/photobiology/man/Afr2T.Rd                               |    4 
 photobiology-0.11.1/photobiology/man/D2.UV653.Rd                            |   11 
 photobiology-0.11.1/photobiology/man/D65.illuminant.spct.Rd                 |   18 
 photobiology-0.11.1/photobiology/man/Ler_leaf.spct.Rd                       |   38 
 photobiology-0.11.1/photobiology/man/T2A.Rd                                 |   51 
 photobiology-0.11.1/photobiology/man/T2Afr.Rd                               |   49 
 photobiology-0.11.1/photobiology/man/add_attr2tb.Rd                         |    8 
 photobiology-0.11.1/photobiology/man/any2T.Rd                               |    4 
 photobiology-0.11.1/photobiology/man/as_quantum.Rd                          |    4 
 photobiology-0.11.1/photobiology/man/black_body.spct.Rd                     |   28 
 photobiology-0.11.1/photobiology/man/ccd.spct.Rd                            |   18 
 photobiology-0.11.1/photobiology/man/checkTimeUnit.Rd                       |    1 
 photobiology-0.11.1/photobiology/man/clear.spct.Rd                          |   30 
 photobiology-0.11.1/photobiology/man/convertTfrType.Rd                      |   46 
 photobiology-0.11.1/photobiology/man/convertThickness.Rd                    |    1 
 photobiology-0.11.1/photobiology/man/convertTimeUnit.Rd                     |    1 
 photobiology-0.11.1/photobiology/man/despike.Rd                             |   28 
 photobiology-0.11.1/photobiology/man/e2q.Rd                                 |    2 
 photobiology-0.11.1/photobiology/man/e2qmol_multipliers.Rd                  |    4 
 photobiology-0.11.1/photobiology/man/e2quantum_multipliers.Rd               |    4 
 photobiology-0.11.1/photobiology/man/e_irrad.Rd                             |   20 
 photobiology-0.11.1/photobiology/man/e_ratio.Rd                             |   40 
 photobiology-0.11.1/photobiology/man/eq_ratio.Rd                            |   47 
 photobiology-0.11.1/photobiology/man/filter_cps.mspct.Rd                    |   18 
 photobiology-0.11.1/photobiology/man/fscale.Rd                              |    9 
 photobiology-0.11.1/photobiology/man/getFilterProperties.Rd                 |    1 
 photobiology-0.11.1/photobiology/man/getHowMeasured.Rd                      |    1 
 photobiology-0.11.1/photobiology/man/getIdFactor.Rd                         |    2 
 photobiology-0.11.1/photobiology/man/getInstrDesc.Rd                        |    1 
 photobiology-0.11.1/photobiology/man/getInstrSettings.Rd                    |    1 
 photobiology-0.11.1/photobiology/man/getNormalized.Rd                       |   11 
 photobiology-0.11.1/photobiology/man/getSoluteProperties.Rd                 |    1 
 photobiology-0.11.1/photobiology/man/getTimeUnit.Rd                         |    1 
 photobiology-0.11.1/photobiology/man/getWhatMeasured.Rd                     |    1 
 photobiology-0.11.1/photobiology/man/getWhenMeasured.Rd                     |    1 
 photobiology-0.11.1/photobiology/man/getWhereMeasured.Rd                    |    1 
 photobiology-0.11.1/photobiology/man/get_attributes.Rd                      |    1 
 photobiology-0.11.1/photobiology/man/green_leaf.spct.Rd                     |   18 
 photobiology-0.11.1/photobiology/man/irrad.Rd                               |   25 
 photobiology-0.11.1/photobiology/man/isValidInstrDesc.Rd                    |    1 
 photobiology-0.11.1/photobiology/man/isValidInstrSettings.Rd                |    1 
 photobiology-0.11.1/photobiology/man/is_normalized.Rd                       |    6 
 photobiology-0.11.1/photobiology/man/normalize.Rd                           |   76 
 photobiology-0.11.1/photobiology/man/phenylalanine.spct.Rd                  |   18 
 photobiology-0.11.1/photobiology/man/photodiode.spct.Rd                     |   18 
 photobiology-0.11.1/photobiology/man/pull_sample.Rd                         |    9 
 photobiology-0.11.1/photobiology/man/q2e.Rd                                 |    6 
 photobiology-0.11.1/photobiology/man/q_irrad.Rd                             |   18 
 photobiology-0.11.1/photobiology/man/q_ratio.Rd                             |   43 
 photobiology-0.11.1/photobiology/man/qe_ratio.Rd                            |   25 
 photobiology-0.11.1/photobiology/man/rbindspct.Rd                           |   10 
 photobiology-0.11.1/photobiology/man/select_spct_attributes.Rd              |    3 
 photobiology-0.11.1/photobiology/man/setBSWFUsed.Rd                         |   65 
 photobiology-0.11.1/photobiology/man/setFilterProperties.Rd                 |    1 
 photobiology-0.11.1/photobiology/man/setHowMeasured.Rd                      |    1 
 photobiology-0.11.1/photobiology/man/setInstrDesc.Rd                        |    1 
 photobiology-0.11.1/photobiology/man/setInstrSettings.Rd                    |    1 
 photobiology-0.11.1/photobiology/man/setResponseType.Rd                     |   16 
 photobiology-0.11.1/photobiology/man/setRfrType.Rd                          |   65 
 photobiology-0.11.1/photobiology/man/setSoluteProperties.Rd                 |    1 
 photobiology-0.11.1/photobiology/man/setTfrType.Rd                          |  102 
 photobiology-0.11.1/photobiology/man/setTimeUnit.Rd                         |    1 
 photobiology-0.11.1/photobiology/man/setWhatMeasured.Rd                     |    1 
 photobiology-0.11.1/photobiology/man/setWhenMeasured.Rd                     |    1 
 photobiology-0.11.1/photobiology/man/setWhereMeasured.Rd                    |    1 
 photobiology-0.11.1/photobiology/man/spct_attr2tb.Rd                        |    1 
 photobiology-0.11.1/photobiology/man/spct_metadata.Rd                       |    1 
 photobiology-0.11.1/photobiology/man/spikes.Rd                              |   16 
 photobiology-0.11.1/photobiology/man/subset2mspct.Rd                        |    4 
 photobiology-0.11.1/photobiology/man/subset_attributes.Rd                   |only
 photobiology-0.11.1/photobiology/man/sun.spct.Rd                            |   32 
 photobiology-0.11.1/photobiology/man/sun_daily.spct.Rd                      |only
 photobiology-0.11.1/photobiology/man/sun_evening.spct.Rd                    |only
 photobiology-0.11.1/photobiology/man/thin_wl.Rd                             |   62 
 photobiology-0.11.1/photobiology/man/trimInstrDesc.Rd                       |    1 
 photobiology-0.11.1/photobiology/man/trimInstrSettings.Rd                   |    1 
 photobiology-0.11.1/photobiology/man/two_filters.spct.Rd                    |only
 photobiology-0.11.1/photobiology/man/valleys.Rd                             |    1 
 photobiology-0.11.1/photobiology/man/water.spct.Rd                          |   18 
 photobiology-0.11.1/photobiology/man/white_led.source_spct.Rd               |   46 
 photobiology-0.11.1/photobiology/man/wls_at_target.Rd                       |   12 
 photobiology-0.11.1/photobiology/vignettes/userguide-1-radiation.Rmd        |  183 
 148 files changed, 4316 insertions(+), 3034 deletions(-)

More information about photobiology at CRAN
Permanent link

Package glmmrBase updated to version 0.7.1 with previous version 0.6.2 dated 2024-01-19

Title: Generalised Linear Mixed Models in R
Description: Specification, analysis, simulation, and fitting of generalised linear mixed models. Includes Markov Chain Monte Carlo Maximum likelihood and Laplace approximation model fitting for a range of models, non-linear fixed effect specifications, a wide range of flexible covariance functions that can be combined arbitrarily, robust and bias-corrected standard error estimation, power calculation, data simulation, and more. See <https://samuel-watson.github.io/glmmr-web/> for a detailed manual.
Author: Sam Watson [aut, cre]
Maintainer: Sam Watson <S.I.Watson@bham.ac.uk>

Diff between glmmrBase versions 0.6.2 dated 2024-01-19 and 0.7.1 dated 2024-02-26

 DESCRIPTION                            |   14 -
 MD5                                    |   88 ++++---
 NAMESPACE                              |    5 
 R/R6Model.R                            |  383 ++++++++++++++++++++++----------
 R/RcppExports.R                        |   28 ++
 R/extrafunctions.R                     |    9 
 R/printfunctions.R                     |   55 ++++
 R/stanmodels.R                         |only
 build/partial.rdb                      |binary
 configure                              |only
 configure.win                          |only
 inst/cmdstan                           |only
 inst/include/glmmr.h                   |    3 
 inst/include/glmmr/calculator.hpp      |    5 
 inst/include/glmmr/linearpredictor.hpp |   15 +
 inst/include/glmmr/model.hpp           |  117 ++++++---
 inst/include/glmmr/modelmcmc.hpp       |   54 ++--
 inst/include/glmmr/modeloptim.hpp      |  390 +++++++++++++++++++++++++--------
 inst/include/glmmr/nngpcovariance.hpp  |   22 +
 inst/include/glmmr/optim/optim.h       |    2 
 inst/include/glmmr/randomeffects.hpp   |   19 +
 inst/include/stan_meta_header.hpp      |only
 inst/stan/mcml_bernoulli.stan          |   38 +--
 inst/stan/mcml_beta.stan               |   29 +-
 inst/stan/mcml_binomial.stan           |   38 +--
 inst/stan/mcml_gamma.stan              |   35 +-
 inst/stan/mcml_gaussian.stan           |   25 +-
 inst/stan/mcml_poisson.stan            |   24 +-
 man/Model.Rd                           |  125 +++++-----
 man/coef.mcml.Rd                       |only
 man/fixed.effects.Rd                   |only
 man/glmmrBase-package.Rd               |   21 +
 man/logLik.mcml.Rd                     |only
 man/mcnr_family.Rd                     |    4 
 man/random.effects.Rd                  |only
 man/summary.mcml.Rd                    |    1 
 src/Makevars                           |   10 
 src/Makevars.win                       |   10 
 src/RcppExports.cpp                    |  104 ++++++++
 src/model_module.cpp                   |    4 
 src/model_module_extension.cpp         |   71 ++++++
 src/stanExports_mcml_bernoulli.cc      |only
 src/stanExports_mcml_bernoulli.h       |only
 src/stanExports_mcml_beta.cc           |only
 src/stanExports_mcml_beta.h            |only
 src/stanExports_mcml_binomial.cc       |only
 src/stanExports_mcml_binomial.h        |only
 src/stanExports_mcml_gamma.cc          |only
 src/stanExports_mcml_gamma.h           |only
 src/stanExports_mcml_gaussian.cc       |only
 src/stanExports_mcml_gaussian.h        |only
 src/stanExports_mcml_poisson.cc        |only
 src/stanExports_mcml_poisson.h         |only
 53 files changed, 1259 insertions(+), 489 deletions(-)

More information about glmmrBase at CRAN
Permanent link

Package rfm updated to version 0.3.0 with previous version 0.2.2 dated 2020-07-21

Title: Recency, Frequency and Monetary Value Analysis
Description: Tools for RFM (recency, frequency and monetary value) analysis. Generate RFM score from both transaction and customer level data. Visualize the relationship between recency, frequency and monetary value using heatmap, histograms, bar charts and scatter plots. Includes a 'shiny' app for interactive segmentation. References: i. Blattberg R.C., Kim BD., Neslin S.A (2008) <doi:10.1007/978-0-387-72579-6_12>.
Author: Aravind Hebbali [aut, cre]
Maintainer: Aravind Hebbali <hebbali.aravind@gmail.com>

Diff between rfm versions 0.2.2 dated 2020-07-21 and 0.3.0 dated 2024-02-26

 rfm-0.2.2/rfm/R/rfm-launch-shiny-app.R                 |only
 rfm-0.2.2/rfm/inst/doc/rfm-customer-level-data.R       |only
 rfm-0.2.2/rfm/inst/doc/rfm-customer-level-data.Rmd     |only
 rfm-0.2.2/rfm/inst/doc/rfm-customer-level-data.html    |only
 rfm-0.2.2/rfm/inst/doc/rfm-transaction-level-data.R    |only
 rfm-0.2.2/rfm/inst/doc/rfm-transaction-level-data.Rmd  |only
 rfm-0.2.2/rfm/inst/doc/rfm-transaction-level-data.html |only
 rfm-0.2.2/rfm/man/rfm_bar_chart.Rd                     |only
 rfm-0.2.2/rfm/man/rfm_heatmap.Rd                       |only
 rfm-0.2.2/rfm/man/rfm_hist_data.Rd                     |only
 rfm-0.2.2/rfm/man/rfm_histograms.Rd                    |only
 rfm-0.2.2/rfm/man/rfm_order_dist.Rd                    |only
 rfm-0.2.2/rfm/man/rfm_table_customer_2.Rd              |only
 rfm-0.2.2/rfm/vignettes/rfm-customer-level-data.Rmd    |only
 rfm-0.2.2/rfm/vignettes/rfm-transaction-level-data.Rmd |only
 rfm-0.3.0/rfm/DESCRIPTION                              |   16 
 rfm-0.3.0/rfm/MD5                                      |  144 +-
 rfm-0.3.0/rfm/NAMESPACE                                |   68 +
 rfm-0.3.0/rfm/NEWS.md                                  |   17 
 rfm-0.3.0/rfm/R/rfm-animate.R                          |only
 rfm-0.3.0/rfm/R/rfm-data.R                             |   12 
 rfm-0.3.0/rfm/R/rfm-ggplot.R                           |only
 rfm-0.3.0/rfm/R/rfm-plotly.R                           |only
 rfm-0.3.0/rfm/R/rfm-plots-data.R                       |  123 +-
 rfm-0.3.0/rfm/R/rfm-plots.R                            |  610 ++++++---
 rfm-0.3.0/rfm/R/rfm-report.R                           |only
 rfm-0.3.0/rfm/R/rfm-segment.R                          | 1043 +++++++++++++++--
 rfm-0.3.0/rfm/R/rfm-shiny-app.R                        |only
 rfm-0.3.0/rfm/R/rfm-table-customer-2.R                 |  174 --
 rfm-0.3.0/rfm/R/rfm-table-customer.R                   |  164 --
 rfm-0.3.0/rfm/R/rfm-table-transaction.R                |  192 +--
 rfm-0.3.0/rfm/R/rfm.R                                  |   10 
 rfm-0.3.0/rfm/R/utils.R                                |   62 -
 rfm-0.3.0/rfm/R/zzz.R                                  |   13 
 rfm-0.3.0/rfm/README.md                                |  249 +---
 rfm-0.3.0/rfm/build/vignette.rds                       |binary
 rfm-0.3.0/rfm/data/rfm_data_customer.rda               |binary
 rfm-0.3.0/rfm/data/rfm_data_orders.rda                 |binary
 rfm-0.3.0/rfm/inst/doc/rfm-introduction.R              |only
 rfm-0.3.0/rfm/inst/doc/rfm-introduction.Rmd            |only
 rfm-0.3.0/rfm/inst/doc/rfm-introduction.html           |only
 rfm-0.3.0/rfm/inst/template                            |only
 rfm-0.3.0/rfm/man/rfm.Rd                               |   16 
 rfm-0.3.0/rfm/man/rfm_barchart_data.Rd                 |    4 
 rfm-0.3.0/rfm/man/rfm_create_report.Rd                 |only
 rfm-0.3.0/rfm/man/rfm_data_customer.Rd                 |    3 
 rfm-0.3.0/rfm/man/rfm_data_orders.Rd                   |    9 
 rfm-0.3.0/rfm/man/rfm_heatmap_data.Rd                  |    4 
 rfm-0.3.0/rfm/man/rfm_launch_app.Rd                    |    2 
 rfm-0.3.0/rfm/man/rfm_plot_bar_chart.Rd                |only
 rfm-0.3.0/rfm/man/rfm_plot_heatmap.Rd                  |only
 rfm-0.3.0/rfm/man/rfm_plot_histogram.Rd                |only
 rfm-0.3.0/rfm/man/rfm_plot_median_recency.Rd           |  132 +-
 rfm-0.3.0/rfm/man/rfm_plot_order_dist.Rd               |only
 rfm-0.3.0/rfm/man/rfm_plot_revenue_dist.Rd             |only
 rfm-0.3.0/rfm/man/rfm_plot_segment.Rd                  |only
 rfm-0.3.0/rfm/man/rfm_plot_segment_scatter.Rd          |only
 rfm-0.3.0/rfm/man/rfm_plot_segment_summary.Rd          |only
 rfm-0.3.0/rfm/man/rfm_rm_plot.Rd                       |   59 
 rfm-0.3.0/rfm/man/rfm_segment.Rd                       |   35 
 rfm-0.3.0/rfm/man/rfm_segment_summary.Rd               |only
 rfm-0.3.0/rfm/man/rfm_table_customer.Rd                |   27 
 rfm-0.3.0/rfm/man/rfm_table_order.Rd                   |   22 
 rfm-0.3.0/rfm/tests/testthat.R                         |   16 
 rfm-0.3.0/rfm/tests/testthat/_snaps                    |only
 rfm-0.3.0/rfm/tests/testthat/test-rfm-plotly.R         |only
 rfm-0.3.0/rfm/tests/testthat/test-rfm-plots.R          |  179 ++
 rfm-0.3.0/rfm/tests/testthat/test-rfm-segment.R        |   30 
 rfm-0.3.0/rfm/tests/testthat/test-rfm-table.R          |   36 
 rfm-0.3.0/rfm/tests/testthat/test-utils.R              |   28 
 rfm-0.3.0/rfm/tools/README-heatmap-1.png               |binary
 rfm-0.3.0/rfm/tools/README-rfmhist-1.png               |binary
 rfm-0.3.0/rfm/tools/README-rfmhist-2.png               |only
 rfm-0.3.0/rfm/tools/README-rfmorders-1.png             |binary
 rfm-0.3.0/rfm/vignettes/rfm-introduction.Rmd           |only
 75 files changed, 2313 insertions(+), 1186 deletions(-)

More information about rfm at CRAN
Permanent link

Package minimaxApprox updated to version 0.4.0 with previous version 0.3.0 dated 2024-01-25

Title: Implementation of Remez Algorithm for Polynomial and Rational Function Approximation
Description: Implements the algorithm of Remez (1962) for polynomial minimax approximation and of Cody et al. (1968) <doi:10.1007/BF02162506> for rational minimax approximation.
Author: Avraham Adler [aut, cre, cph]
Maintainer: Avraham Adler <Avraham.Adler@gmail.com>

Diff between minimaxApprox versions 0.3.0 dated 2024-01-25 and 0.4.0 dated 2024-02-26

 DESCRIPTION                        |    8 -
 MD5                                |   58 +++++++------
 NAMESPACE                          |    2 
 R/Chebyshev.R                      |only
 R/MiniMaxApprox.R                  |  106 +++++++++++++++++-------
 R/Monomial.R                       |only
 R/RemezPolynomial.R                |   33 +++----
 R/RemezRational.R                  |   50 +++++------
 R/methods.R                        |   35 ++++++-
 R/shared.R                         |   81 ++++++++++--------
 README.md                          |    8 -
 build/partial.rdb                  |binary
 inst/CITATION                      |    2 
 inst/NEWS.Rd                       |   45 +++++++++-
 inst/tinytest/test_Chebyshev.R     |only
 inst/tinytest/test_MiniMaxApprox.R |  162 +++++++++++++++++++++++--------------
 inst/tinytest/test_methods.R       |   15 +++
 inst/tinytest/test_monomial.R      |only
 inst/tinytest/test_polynomial.R    |    5 -
 inst/tinytest/test_rational.R      |    5 -
 inst/tinytest/test_shared.R        |   99 +++++++++++-----------
 man/MiniMaxApprox.Rd               |   98 +++++++++++++++-------
 man/coef.minimaxApprox.Rd          |   14 ++-
 man/minimaxApprox-internal.Rd      |   29 ++++--
 man/minimaxErr.Rd                  |    2 
 man/minimaxEval.Rd                 |   11 +-
 man/plot.minimaxApprox.Rd          |    2 
 man/print.minimaxApprox.Rd         |    4 
 src/Chebyshev.c                    |only
 src/Chebyshev.h                    |only
 src/Makevars                       |    5 -
 src/compHorner.c                   |   27 +-----
 src/compHorner.h                   |only
 src/init.c                         |only
 34 files changed, 568 insertions(+), 338 deletions(-)

More information about minimaxApprox at CRAN
Permanent link

Package HiResTEC updated to version 0.62.3 with previous version 0.62 dated 2023-02-22

Title: Non-Targeted Fluxomics on High-Resolution Mass-Spectrometry Data
Description: Identifying labeled compounds in a 13C-tracer experiment in non-targeted fashion is a cumbersome process. This package facilitates such type of analyses by providing high level quality control plots, deconvoluting and evaluating spectra and performing a multitude of tests in an automatic fashion. The main idea is to use changing intensity ratios of ion pairs from peak list generated with 'xcms' as candidates and evaluate those against base peak chromatograms and spectra information within the raw measurement data automatically. The functionality is described in Hoffmann et al. (2018) <doi:10.1021/acs.analchem.8b00356>.
Author: Jan Lisec [aut, cre] , Friederike Hoffmann [aut]
Maintainer: Jan Lisec <jan.lisec@bam.de>

Diff between HiResTEC versions 0.62 dated 2023-02-22 and 0.62.3 dated 2024-02-26

 HiResTEC-0.62.3/HiResTEC/DESCRIPTION                             |   18 +++--
 HiResTEC-0.62.3/HiResTEC/MD5                                     |   24 +++----
 HiResTEC-0.62.3/HiResTEC/NAMESPACE                               |    3 
 HiResTEC-0.62.3/HiResTEC/R/DetermineElementComposition.R         |    3 
 HiResTEC-0.62.3/HiResTEC/R/EvaluateCandidateListAgainstRawData.R |    5 -
 HiResTEC-0.62.3/HiResTEC/R/getMultipleBPC.R                      |   23 ++++++-
 HiResTEC-0.62.3/HiResTEC/R/plotBPC.R                             |    8 ++
 HiResTEC-0.62.3/HiResTEC/R/plotMID.R                             |   31 +++++++---
 HiResTEC-0.62.3/HiResTEC/README.md                               |only
 HiResTEC-0.62.3/HiResTEC/man/getMultipleBPC.Rd                   |    6 -
 HiResTEC-0.62.3/HiResTEC/man/plotBPC.Rd                          |    6 +
 HiResTEC-0.62.3/HiResTEC/man/plotMID.Rd                          |   11 +--
 HiResTEC-0.62/HiResTEC/R/CorMID_reexport.R                       |only
 HiResTEC-0.62/HiResTEC/man/CalcTheoreticalMDV.Rd                 |only
 HiResTEC-0.62/HiResTEC/man/CorMID.Rd                             |only
 15 files changed, 87 insertions(+), 51 deletions(-)

More information about HiResTEC at CRAN
Permanent link

Package AcademicThemes updated to version 0.0.2 with previous version 0.0.1 dated 2023-03-27

Title: Colour Plots with Palettes from Academic Institutions
Description: Functionality to allow users to easily colour plots with the colour palettes of various academic institutions.
Author: Hugh Warden [aut, cre]
Maintainer: Hugh Warden <hugh.warden@outlook.com>

Diff between AcademicThemes versions 0.0.1 dated 2023-03-27 and 0.0.2 dated 2024-02-26

 DESCRIPTION                                |    6 
 MD5                                        |   22 +-
 NEWS.md                                    |    5 
 R/colour_palettes.R                        |    3 
 inst/doc/AcademicThemes.Rmd                |    8 
 inst/doc/AcademicThemes.html               |  290 ++++++++++++++---------------
 inst/doc/Colour_Palettes.Rmd               |    2 
 inst/doc/Colour_Palettes.html              |   21 +-
 tests/testthat/test-ggplot2_colour_layer.R |   12 -
 tests/testthat/test-ggplot2_fill_layer.R   |   12 -
 vignettes/AcademicThemes.Rmd               |    8 
 vignettes/Colour_Palettes.Rmd              |    2 
 12 files changed, 217 insertions(+), 174 deletions(-)

More information about AcademicThemes at CRAN
Permanent link

Package epiomics updated to version 1.1.0 with previous version 1.0.0 dated 2023-03-15

Title: Analysis of Omics Data in Observational Studies
Description: A collection of fast and flexible functions for analyzing omics data in observational studies. Multiple different approaches for integrating multiple environmental/genetic factors, omics data, and/or phenotype data are implemented. This includes functions for performing omics wide association studies with one or more variables of interest as the exposure or outcome; a function for performing a meet in the middle analysis for linking exposures, omics, and outcomes (as described by Chadeau-Hyam et al., (2010) <doi:10.3109/1354750X.2010.533285>); and a function for performing a mixtures analysis across all omics features using quantile-based g-Computation (as described by Keil et al., (2019) <doi:10.1289/EHP5838>).
Author: Jesse Goodrich [aut, cre]
Maintainer: Jesse Goodrich <jagoodri@usc.edu>

Diff between epiomics versions 1.0.0 dated 2023-03-15 and 1.1.0 dated 2024-02-26

 epiomics-1.0.0/epiomics/R/owas_mixed_effects.R                   |only
 epiomics-1.0.0/epiomics/man/owas_mixed_effects.Rd                |only
 epiomics-1.0.0/epiomics/tests/testthat/test-owas_mixed_effects.R |only
 epiomics-1.1.0/epiomics/DESCRIPTION                              |    9 
 epiomics-1.1.0/epiomics/MD5                                      |   32 
 epiomics-1.1.0/epiomics/NAMESPACE                                |    6 
 epiomics-1.1.0/epiomics/NEWS.md                                  |   23 
 epiomics-1.1.0/epiomics/R/coef_plot_from_owas.R                  |only
 epiomics-1.1.0/epiomics/R/depreciated                            |only
 epiomics-1.1.0/epiomics/R/meet_in_middle.R                       |  318 ++--
 epiomics-1.1.0/epiomics/R/owas.R                                 |  640 +++++-----
 epiomics-1.1.0/epiomics/R/owas_clogit.R                          |  350 ++---
 epiomics-1.1.0/epiomics/R/owas_qgcomp.R                          |  460 +++----
 epiomics-1.1.0/epiomics/R/volcano_owas.R                         |  182 +-
 epiomics-1.1.0/epiomics/README.md                                |  284 ++--
 epiomics-1.1.0/epiomics/build/partial.rdb                        |binary
 epiomics-1.1.0/epiomics/man/coef_plot_from_owas.Rd               |only
 epiomics-1.1.0/epiomics/man/owas_qgcomp.Rd                       |    2 
 epiomics-1.1.0/epiomics/tests/testthat/depreciated               |only
 epiomics-1.1.0/epiomics/tests/testthat/test_coef_plot.R          |only
 epiomics-1.1.0/epiomics/tests/testthat/test_volcano_owas.R       |  115 -
 21 files changed, 1213 insertions(+), 1208 deletions(-)

More information about epiomics at CRAN
Permanent link


Built and running on Debian GNU/Linux using R, littler and blosxom. Styled with Bootstrap.