Title: Haplotype-Aware CNV Analysis from scRNA-Seq
Description: A computational method that infers copy number variations (CNVs) in cancer scRNA-seq data and reconstructs the tumor phylogeny. 'numbat' integrates signals from gene expression, allelic ratio, and population haplotype structures to accurately infer allele-specific CNVs in single cells and reconstruct their lineage relationship. 'numbat' can be used to: 1. detect allele-specific copy number variations from single-cells; 2. differentiate tumor versus normal cells in the tumor microenvironment; 3. infer the clonal architecture and evolutionary history of profiled tumors. 'numbat' does not require tumor/normal-paired DNA or genotype data, but operates solely on the donor scRNA-data data (for example, 10x Cell Ranger output). Additional examples and documentations are available at <https://kharchenkolab.github.io/numbat/>. For details on the method please see Gao et al. Nature Biotechnology (2022) <doi:10.1038/s41587-022-01468-y>.
Author: Teng Gao [cre, aut],
Hirak Sarkar [aut],
Evan Biederstedt [aut],
Peter Kharchenko [aut]
Maintainer: Teng Gao <tgao@g.harvard.edu>
Diff between numbat versions 1.1.0 dated 2022-11-29 and 1.2.1 dated 2023-01-10
numbat-1.1.0/numbat/man/ladderize.Rd |only numbat-1.2.1/numbat/DESCRIPTION | 9 numbat-1.2.1/numbat/MD5 | 56 +-- numbat-1.2.1/numbat/NAMESPACE | 2 numbat-1.2.1/numbat/NEWS.md | 8 numbat-1.2.1/numbat/R/RcppExports.R | 4 numbat-1.2.1/numbat/R/class.R | 113 ------- numbat-1.2.1/numbat/R/data.R | 4 numbat-1.2.1/numbat/R/diagnostics.R | 146 +++++++++ numbat-1.2.1/numbat/R/genotyping.R | 6 numbat-1.2.1/numbat/R/main.R | 72 ++-- numbat-1.2.1/numbat/R/trees.R | 64 ---- numbat-1.2.1/numbat/R/utils.R | 37 +- numbat-1.2.1/numbat/R/vis.R | 374 +++++++++++++----------- numbat-1.2.1/numbat/README.md | 8 numbat-1.2.1/numbat/data/gtf_hg19.rda |binary numbat-1.2.1/numbat/data/gtf_hg38.rda |binary numbat-1.2.1/numbat/data/gtf_mm10.rda |only numbat-1.2.1/numbat/inst/bin/pileup_and_phase.R | 19 - numbat-1.2.1/numbat/man/annotate_genes.Rd |only numbat-1.2.1/numbat/man/get_ordered_tips.Rd |only numbat-1.2.1/numbat/man/gtf_hg19.Rd | 2 numbat-1.2.1/numbat/man/gtf_hg38.Rd | 2 numbat-1.2.1/numbat/man/gtf_mm10.Rd |only numbat-1.2.1/numbat/man/make_group_bulks.Rd | 1 numbat-1.2.1/numbat/man/plot_phylo_heatmap.Rd | 14 numbat-1.2.1/numbat/man/retest_bulks.Rd | 1 numbat-1.2.1/numbat/man/run_group_hmms.Rd | 1 numbat-1.2.1/numbat/man/run_numbat.Rd | 5 numbat-1.2.1/numbat/man/t.test.pval.Rd |only numbat-1.2.1/numbat/src/RcppExports.cpp | 17 - numbat-1.2.1/numbat/src/misc.cpp | 32 -- 32 files changed, 541 insertions(+), 456 deletions(-)
Title: A Traceability Focused Grammar of Clinical Data Summary
Description: A traceability focused tool created to simplify the data manipulation necessary to create clinical summaries.
Author: Eli Miller [aut] ,
Mike Stackhouse [aut, cre] ,
Ashley Tarasiewicz [aut],
Nathan Kosiba [ctb] ,
Sadchla Mascary [ctb],
Atorus Research LLC [cph]
Maintainer: Mike Stackhouse <mike.stackhouse@atorusresearch.com>
Diff between Tplyr versions 1.0.2 dated 2022-11-07 and 1.1.0 dated 2023-01-10
DESCRIPTION | 17 MD5 | 102 +-- NAMESPACE | 5 NEWS.md | 7 R/apply_conditional_format.R |only R/count.R | 7 R/format.R | 481 ++++---------- R/num_fmt.R |only R/prebuild.R | 54 - R/regex.R |only R/set_format_strings.R |only R/shift.R | 6 R/str_extractors.R |only R/zzz.R | 2 build/vignette.rds |binary inst/doc/Tplyr.html | 123 +-- inst/doc/count.R | 13 inst/doc/count.Rmd | 18 inst/doc/count.html | 170 ++--- inst/doc/custom-metadata.R | 2 inst/doc/custom-metadata.Rmd | 2 inst/doc/custom-metadata.html | 113 +-- inst/doc/denom.html | 225 +++--- inst/doc/desc.R | 138 ---- inst/doc/desc.Rmd | 187 ----- inst/doc/desc.html | 831 +------------------------ inst/doc/desc_layer_formatting.R |only inst/doc/desc_layer_formatting.Rmd |only inst/doc/desc_layer_formatting.html |only inst/doc/general_string_formatting.R |only inst/doc/general_string_formatting.Rmd |only inst/doc/general_string_formatting.html |only inst/doc/layer_templates.html | 111 +-- inst/doc/metadata.html | 111 +-- inst/doc/options.html | 111 +-- inst/doc/post_processing.R |only inst/doc/post_processing.Rmd |only inst/doc/post_processing.html |only inst/doc/shift.html | 111 +-- inst/doc/table.html | 141 ++-- man/Tplyr.Rd | 3 man/apply_conditional_format.Rd |only man/f_str.Rd | 31 man/get_tplyr_regex.Rd |only man/set_format_strings.Rd | 2 man/str_extractors.Rd |only tests/testthat/_snaps/column_headers.md | 28 tests/testthat/_snaps/count.md | 27 tests/testthat/_snaps/desc.md | 5 tests/testthat/_snaps/layer.md | 12 tests/testthat/_snaps/precision.md | 12 tests/testthat/_snaps/shift.md | 5 tests/testthat/test-apply_conditional_format.R |only tests/testthat/test-format.R | 155 +++- tests/testthat/test-functional.R | 2 tests/testthat/test-num_fmt.R |only tests/testthat/test-regex.R |only tests/testthat/test-str_extractors.R |only vignettes/count.Rmd | 18 vignettes/custom-metadata.Rmd | 2 vignettes/desc.Rmd | 187 ----- vignettes/desc_layer_formatting.Rmd |only vignettes/general_string_formatting.Rmd |only vignettes/post_processing.Rmd |only 64 files changed, 1179 insertions(+), 2398 deletions(-)
Title: Finite Element Modeling for R
Description: Finite element modeling of beam structures and 2D geometries using constant strain triangles. Applies material properties and boundary conditions (load and constraint) to generate a finite element model. The model produces stress, strain, and nodal displacements; a heat map is available to demonstrate regions where output variables are high or low. Also provides options for creating a triangular mesh of 2D geometries. Package developed with reference to: Bathe, K. J. (1996). Finite Element Procedures.[ISBN 978-0-9790049-5-7] -- Seshu, P. (2012). Textbook of Finite Element Analysis. [ISBN-978-81-203-2315-5] -- Mustapha, K. B. (2018). Finite Element Computations in Mechanics with R. [ISBN 9781315144474].
Author: Henna D. Bhramdat
Maintainer: Henna D. Bhramdat <bhramdath@ufl.edu>
Diff between FEA versions 0.0.1 dated 2022-03-08 and 0.0.2 dated 2023-01-10
FEA-0.0.1/FEA/R/ApplyBC.R |only FEA-0.0.1/FEA/R/AutoAdjust.R |only FEA-0.0.1/FEA/R/CompleteFEMStrain.R |only FEA-0.0.1/FEA/R/CompleteFEMStress.R |only FEA-0.0.1/FEA/R/Dimensions.R |only FEA-0.0.1/FEA/R/ElementMat.R |only FEA-0.0.1/FEA/R/ExpandEM.R |only FEA-0.0.1/FEA/R/ExpandSFT.R |only FEA-0.0.1/FEA/R/ForceVector.R |only FEA-0.0.1/FEA/R/GLForces.R |only FEA-0.0.1/FEA/R/GlobalMat.R |only FEA-0.0.1/FEA/R/LocalStress.R |only FEA-0.0.1/FEA/R/ManualAdjust.R |only FEA-0.0.1/FEA/R/NodeDis.R |only FEA-0.0.1/FEA/R/PlotSystem.R |only FEA-0.0.1/FEA/R/ReducedEM.R |only FEA-0.0.1/FEA/R/ReducedSF.R |only FEA-0.0.1/FEA/R/SinglePoly.R |only FEA-0.0.1/FEA/R/SurfaceTraction.R |only FEA-0.0.1/FEA/R/ThreshPts.R |only FEA-0.0.1/FEA/R/triangulate0.R |only FEA-0.0.1/FEA/man/ApplyBC.Rd |only FEA-0.0.1/FEA/man/AutoAdjust.Rd |only FEA-0.0.1/FEA/man/Dimensions.Rd |only FEA-0.0.1/FEA/man/ElementMat.Rd |only FEA-0.0.1/FEA/man/ExpandEM.Rd |only FEA-0.0.1/FEA/man/ExpandSFT.Rd |only FEA-0.0.1/FEA/man/FEMStrain.Rd |only FEA-0.0.1/FEA/man/FEMStress.Rd |only FEA-0.0.1/FEA/man/ForceVector.Rd |only FEA-0.0.1/FEA/man/GLForces.Rd |only FEA-0.0.1/FEA/man/GlobalMat.Rd |only FEA-0.0.1/FEA/man/LocalStress.Rd |only FEA-0.0.1/FEA/man/ManualAdjust.Rd |only FEA-0.0.1/FEA/man/NodeDis.Rd |only FEA-0.0.1/FEA/man/PlotSystem.Rd |only FEA-0.0.1/FEA/man/ReducedEM.Rd |only FEA-0.0.1/FEA/man/ReducedSF.Rd |only FEA-0.0.1/FEA/man/SinglePoly.Rd |only FEA-0.0.1/FEA/man/SurfaceTraction.Rd |only FEA-0.0.1/FEA/man/ThreshPts.Rd |only FEA-0.0.1/FEA/man/triangulate0.Rd |only FEA-0.0.2/FEA/DESCRIPTION | 14 +- FEA-0.0.2/FEA/MD5 | 150 ++++++++++++++++++++++---------- FEA-0.0.2/FEA/NAMESPACE | 55 +++++++---- FEA-0.0.2/FEA/R/ApplyBC.2d.R |only FEA-0.0.2/FEA/R/AutoAdjust.2d.R |only FEA-0.0.2/FEA/R/CompleteFEMStrain.2d.R |only FEA-0.0.2/FEA/R/CompleteFEMStress.2d.R |only FEA-0.0.2/FEA/R/Dimensions.2d.R |only FEA-0.0.2/FEA/R/ElementMat.2d.R |only FEA-0.0.2/FEA/R/EulerBeamFEA.R |only FEA-0.0.2/FEA/R/ExpandEM.2d.R |only FEA-0.0.2/FEA/R/ExpandSFT.2d.R |only FEA-0.0.2/FEA/R/ForceVector.2d.R |only FEA-0.0.2/FEA/R/GLForces.2d.R |only FEA-0.0.2/FEA/R/GlobalMat.2d.R |only FEA-0.0.2/FEA/R/LocalStress.2d.R |only FEA-0.0.2/FEA/R/ManualAdjust.2d.R |only FEA-0.0.2/FEA/R/NodeDis.2d.R |only FEA-0.0.2/FEA/R/PlotSystem.2d.R |only FEA-0.0.2/FEA/R/ReducedEM.2d.R |only FEA-0.0.2/FEA/R/ReducedSF.2d.R |only FEA-0.0.2/FEA/R/SinglePoly.2d.R |only FEA-0.0.2/FEA/R/SurfaceTraction.2d.R |only FEA-0.0.2/FEA/R/ThreshPts.2d.R |only FEA-0.0.2/FEA/R/beamApplyBC.R |only FEA-0.0.2/FEA/R/beamBC.R |only FEA-0.0.2/FEA/R/beamDime.R |only FEA-0.0.2/FEA/R/beamDimensions.R |only FEA-0.0.2/FEA/R/beamElementMat.R |only FEA-0.0.2/FEA/R/beamEmat.R |only FEA-0.0.2/FEA/R/beamExMat.R |only FEA-0.0.2/FEA/R/beamExpandEM.R |only FEA-0.0.2/FEA/R/beamFV.R |only FEA-0.0.2/FEA/R/beamForceVector.R |only FEA-0.0.2/FEA/R/beamGLForces.R |only FEA-0.0.2/FEA/R/beamGLforce.R |only FEA-0.0.2/FEA/R/beamGeo.R |only FEA-0.0.2/FEA/R/beamGloMat.R |only FEA-0.0.2/FEA/R/beamGlobalEM.R |only FEA-0.0.2/FEA/R/beamND.R |only FEA-0.0.2/FEA/R/beamNodeDis.R |only FEA-0.0.2/FEA/R/beamPlotSystem.R |only FEA-0.0.2/FEA/R/beamREM.R |only FEA-0.0.2/FEA/R/beamReducedEM.R |only FEA-0.0.2/FEA/R/beamStress.R |only FEA-0.0.2/FEA/R/beamStressResult.R |only FEA-0.0.2/FEA/R/beamUDL.R |only FEA-0.0.2/FEA/R/beamsUDL.R |only FEA-0.0.2/FEA/R/triangulate0.2d.R |only FEA-0.0.2/FEA/data/beamBC.rda |only FEA-0.0.2/FEA/data/beamDime.rda |only FEA-0.0.2/FEA/data/beamEmat.rda |only FEA-0.0.2/FEA/data/beamExMat.rda |only FEA-0.0.2/FEA/data/beamFV.rda |only FEA-0.0.2/FEA/data/beamGLforce.rda |only FEA-0.0.2/FEA/data/beamGeo.rda |only FEA-0.0.2/FEA/data/beamGloMat.rda |only FEA-0.0.2/FEA/data/beamND.rda |only FEA-0.0.2/FEA/data/beamREM.rda |only FEA-0.0.2/FEA/data/beamStressResult.rda |only FEA-0.0.2/FEA/data/beamsUDL.rda |only FEA-0.0.2/FEA/man/ApplyBC.2d.Rd |only FEA-0.0.2/FEA/man/AutoAdjust.2d.Rd |only FEA-0.0.2/FEA/man/Dimensions.2d.Rd |only FEA-0.0.2/FEA/man/ElementMat.2d.Rd |only FEA-0.0.2/FEA/man/EulerBeamFEA.Rd |only FEA-0.0.2/FEA/man/ExpandEM.2d.Rd |only FEA-0.0.2/FEA/man/ExpandSFT.2d.Rd |only FEA-0.0.2/FEA/man/FEMStrain.2d.Rd |only FEA-0.0.2/FEA/man/FEMStress.2d.Rd |only FEA-0.0.2/FEA/man/ForceVector.2d.Rd |only FEA-0.0.2/FEA/man/GLForces.2d.Rd |only FEA-0.0.2/FEA/man/GlobalMat.2d.Rd |only FEA-0.0.2/FEA/man/LocalStress.2d.Rd |only FEA-0.0.2/FEA/man/ManualAdjust.2d.Rd |only FEA-0.0.2/FEA/man/NodeDis.2d.Rd |only FEA-0.0.2/FEA/man/PlotSystem.2d.Rd |only FEA-0.0.2/FEA/man/ReducedEM.2d.Rd |only FEA-0.0.2/FEA/man/ReducedSF.2d.Rd |only FEA-0.0.2/FEA/man/SinglePoly.2d.Rd |only FEA-0.0.2/FEA/man/SurfaceTraction.2d.Rd |only FEA-0.0.2/FEA/man/ThreshPts.2d.Rd |only FEA-0.0.2/FEA/man/beamApplyBC.Rd |only FEA-0.0.2/FEA/man/beamBC.Rd |only FEA-0.0.2/FEA/man/beamDime.Rd |only FEA-0.0.2/FEA/man/beamDimensions.Rd |only FEA-0.0.2/FEA/man/beamElementMat.Rd |only FEA-0.0.2/FEA/man/beamEmat.Rd |only FEA-0.0.2/FEA/man/beamExMat.Rd |only FEA-0.0.2/FEA/man/beamExpandEM.Rd |only FEA-0.0.2/FEA/man/beamFV.Rd |only FEA-0.0.2/FEA/man/beamForceVector.Rd |only FEA-0.0.2/FEA/man/beamGLForces.Rd |only FEA-0.0.2/FEA/man/beamGLforce.Rd |only FEA-0.0.2/FEA/man/beamGeo.Rd |only FEA-0.0.2/FEA/man/beamGloMat.Rd |only FEA-0.0.2/FEA/man/beamGlobalEM.Rd |only FEA-0.0.2/FEA/man/beamND.Rd |only FEA-0.0.2/FEA/man/beamNodeDis.Rd |only FEA-0.0.2/FEA/man/beamPlotSystem.Rd |only FEA-0.0.2/FEA/man/beamREM.Rd |only FEA-0.0.2/FEA/man/beamReducedEM.Rd |only FEA-0.0.2/FEA/man/beamStress.Rd |only FEA-0.0.2/FEA/man/beamStressResult.Rd |only FEA-0.0.2/FEA/man/beamUDL.Rd |only FEA-0.0.2/FEA/man/beamsUDL.Rd |only FEA-0.0.2/FEA/man/triangulate0.2d.Rd |only 149 files changed, 147 insertions(+), 72 deletions(-)
Title: Use Browser Cookies with 'shiny'
Description: Browser cookies are name-value pairs that are saved in a user's
browser by a website. Cookies allow websites to persist information about
the user and their use of the website. Here we provide tools for working
with cookies in 'shiny' apps, in part by wrapping the 'js-cookie' JavaScript
library <https://github.com/js-cookie/js-cookie>.
Author: Jon Harmon [aut, cre, cph] ,
Klaus Hartl [cph] ,
Fagner Brack [cph]
Maintainer: Jon Harmon <jonthegeek@gmail.com>
Diff between cookies versions 0.2.0 dated 2022-11-30 and 0.2.1 dated 2023-01-10
cookies-0.2.0/cookies/inst/js/js.cookie.js |only cookies-0.2.1/cookies/DESCRIPTION | 8 - cookies-0.2.1/cookies/MD5 | 20 +-- cookies-0.2.1/cookies/NEWS.md | 6 cookies-0.2.1/cookies/R/data_prep.R | 73 ++++++----- cookies-0.2.1/cookies/R/server.R | 8 - cookies-0.2.1/cookies/R/ui_wrapper.R | 31 +++- cookies-0.2.1/cookies/inst/js/js.cookie.min.js |only cookies-0.2.1/cookies/man/add_cookie_handlers.Rd | 4 cookies-0.2.1/cookies/man/cookie_dependency.Rd | 4 cookies-0.2.1/cookies/man/dot-validate_logical_scalar.Rd |only cookies-0.2.1/cookies/man/dot-validate_scalar.Rd |only cookies-0.2.1/cookies/tests/testthat/_snaps/ui_wrapper.md | 88 ++++++++++++-- 13 files changed, 179 insertions(+), 63 deletions(-)
Title: Data Frame Class for Tracking Data
Description: Data frame class for storing collective movement data (e.g. fish
schools, ungulate herds, baboon troops) collected from GPS trackers or
computer vision tracking software.
Author: Simon Garnier [aut, cre]
Maintainer: Simon Garnier <garnier@njit.edu>
Diff between trackdf versions 0.2.2 dated 2021-01-13 and 0.3.0 dated 2023-01-10
trackdf-0.2.2/trackdf/R/dplyr.R |only trackdf-0.2.2/trackdf/man/dot-reclass.Rd |only trackdf-0.2.2/trackdf/man/dplyr_track.Rd |only trackdf-0.2.2/trackdf/man/rbind_track.Rd |only trackdf-0.3.0/trackdf/DESCRIPTION | 21 trackdf-0.3.0/trackdf/MD5 | 66 +- trackdf-0.3.0/trackdf/NAMESPACE | 22 trackdf-0.3.0/trackdf/NEWS.md | 20 trackdf-0.3.0/trackdf/R/conversions.R | 50 + trackdf-0.3.0/trackdf/R/errors.R |only trackdf-0.3.0/trackdf/R/track.R | 23 trackdf-0.3.0/trackdf/R/utils.R | 98 +-- trackdf-0.3.0/trackdf/build/vignette.rds |binary trackdf-0.3.0/trackdf/data/short_tracks.rda |binary trackdf-0.3.0/trackdf/data/tracks.rda |binary trackdf-0.3.0/trackdf/inst/doc/z1_install.Rmd | 2 trackdf-0.3.0/trackdf/inst/doc/z1_install.html | 319 ++++++++++-- trackdf-0.3.0/trackdf/inst/doc/z2_build.R | 2 trackdf-0.3.0/trackdf/inst/doc/z2_build.Rmd | 6 trackdf-0.3.0/trackdf/inst/doc/z2_build.html | 335 ++++++++++-- trackdf-0.3.0/trackdf/inst/doc/z3_manipulate.R | 9 trackdf-0.3.0/trackdf/inst/doc/z3_manipulate.Rmd | 35 - trackdf-0.3.0/trackdf/inst/doc/z3_manipulate.html | 575 +++++++++++++++------- trackdf-0.3.0/trackdf/man/bind_tracks.Rd |only trackdf-0.3.0/trackdf/man/conversions.Rd | 2 trackdf-0.3.0/trackdf/man/dot-Mode.Rd |only trackdf-0.3.0/trackdf/man/duplicated_t.Rd |only trackdf-0.3.0/trackdf/man/duplicated_xyt.Rd |only trackdf-0.3.0/trackdf/man/inconsistent_xy.Rd |only trackdf-0.3.0/trackdf/man/is_geo.Rd | 4 trackdf-0.3.0/trackdf/man/missing_t.Rd |only trackdf-0.3.0/trackdf/man/missing_xy.Rd |only trackdf-0.3.0/trackdf/man/n_dims.Rd | 4 trackdf-0.3.0/trackdf/man/n_tracks.Rd | 4 trackdf-0.3.0/trackdf/man/projection.Rd | 12 trackdf-0.3.0/trackdf/man/track_.Rd | 4 trackdf-0.3.0/trackdf/tests |only trackdf-0.3.0/trackdf/vignettes/z1_install.Rmd | 2 trackdf-0.3.0/trackdf/vignettes/z2_build.Rmd | 6 trackdf-0.3.0/trackdf/vignettes/z3_manipulate.Rmd | 35 - 40 files changed, 1167 insertions(+), 489 deletions(-)
Title: Modeling the Kinetics of Carbon Dioxide Production in Alcoholic
Fermentation
Description: Developed to help researchers who need to model the kinetics of carbon dioxide (CO2) production in alcoholic fermentation of wines, beers and other fermented products. The following models are available for modeling the carbon dioxide production curve as a function of time: 5PL, Gompertz and 4PL. This package has different functions, which applied can: perform the modeling of the data obtained in the fermentation and return the coefficients, analyze the model fit and return different statistical metrics, and calculate the kinetic parameters: Maximum production of carbon dioxide; Maximum rate of production of carbon dioxide; Moment in which maximum fermentation rate occurs; Duration of the latency phase for carbon dioxide production; Carbon dioxide produced until maximum fermentation rate occurs. In addition, a function that generates graphs with the observed and predicted data from the models, isolated and combined, is available. Gava, A., Borsato, D., & Ficagna, E. (2020)."Effect [...truncated...]
Author: Angelo Gava [aut, cre]
Maintainer: Angelo Gava <gava.angelogava@gmail.com>
Diff between OenoKPM versions 2.1.3 dated 2022-11-23 and 2.2.1 dated 2023-01-10
DESCRIPTION | 6 +++--- MD5 | 10 ++++++---- NAMESPACE | 1 + R/kp.R | 6 +++--- R/plot_fit.R | 26 +++++++++++++------------- R/pred.R |only man/pred.Rd |only 7 files changed, 26 insertions(+), 23 deletions(-)
Title: Flexible Tools for Estimating Interactions
Description: A set of functions to estimate interactions flexibly in the face of possibly many controls. Implements the procedures described in Blackwell and Olson (2022) <doi:10.1017/pan.2021.19>.
Author: Matthew Blackwell [aut, cre] ,
Olson Michael [aut]
Maintainer: Matthew Blackwell <mblackwell@gov.harvard.edu>
Diff between inters versions 0.1 dated 2022-04-22 and 0.2.0 dated 2023-01-10
DESCRIPTION | 10 ++++---- MD5 | 12 +++++----- NAMESPACE | 2 + R/lasso_interactions.R | 43 +++++++++++++++++++++++------------- build/partial.rdb |binary build/vignette.rds |binary inst/doc/post-double-selection.html | 25 +++++++++++++------- 7 files changed, 57 insertions(+), 35 deletions(-)
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2023-01-06 1.2.11
2022-10-08 1.2.9
Title: Tools for Handling Indices and Proportions in Small Area
Estimation
Description: It allows for mapping proportions and indicators defined on the unit interval. It implements Beta-based small area methods comprising the classical Beta regression models, the Flexible Beta model and Zero and/or One Inflated extensions (Janicki 2020 <doi:10.1080/03610926.2019.1570266>). Such methods, developed within a Bayesian framework through Stan <https://mc-stan.org/>, come equipped with a set of diagnostics and complementary tools, visualizing and exporting functions. A Shiny application with a user-friendly interface can be launched to further simplify the process.
Author: Silvia De Nicolò [aut, cre] ,
Aldo Gardini [aut]
Maintainer: Silvia De Nicolò <silvia.denicolo@unibo.it>
Diff between tipsae versions 0.0.9 dated 2022-11-03 and 0.0.12 dated 2023-01-10
DESCRIPTION | 16 MD5 | 36 R/check_fit.R | 63 R/fit_sae.R | 35 R/smoothing.R | 234 +- R/util_fit.R | 9 build/partial.rdb |binary build/vignette.rds |binary inst/REFERENCES.bib | 7 inst/doc/shiny_tipsae_vignette.pdf |binary inst/doc/tipsae_vignette.pdf |binary inst/shiny_tipsae/server_files/data_shapefile_server.R | 2 inst/stan/global.stan | 12 inst/stan/include/data.stan | 6 inst/stan/include/gen_reff_OOS.stan | 2 man/emilia_shp.Rd | 7 man/fit_sae.Rd | 13 man/smoothing.Rd | 4 src/stanExports_global.h | 1459 ++++++++--------- 19 files changed, 1043 insertions(+), 862 deletions(-)
Title: Access EPA 'ATTAINS' Data
Description: An R interface to United States Environmental Protection Agency (EPA)
Assessment, Total Maximum Daily Load (TMDL) Tracking and Implementation System
('ATTAINS') data. 'ATTAINS' is the EPA database used to track information
provided by states about water quality assessments conducted under federal
Clean Water Act requirements. ATTAINS information and API information is available at <https://www.epa.gov/waterdata/attains>.
Author: Michael Schramm [aut, cre, cph]
Maintainer: Michael Schramm <mpschramm@gmail.com>
Diff between rATTAINS versions 0.1.3 dated 2021-11-03 and 0.1.4 dated 2023-01-10
rATTAINS-0.1.3/rATTAINS/R/onload.R |only rATTAINS-0.1.3/rATTAINS/R/rATTAINS_caching.R |only rATTAINS-0.1.3/rATTAINS/R/rATTAINS_opts.R |only rATTAINS-0.1.3/rATTAINS/man/rATTAINS_caching.Rd |only rATTAINS-0.1.3/rATTAINS/man/rATTAINS_options.Rd |only rATTAINS-0.1.4/rATTAINS/DESCRIPTION | 17 rATTAINS-0.1.4/rATTAINS/MD5 | 78 - rATTAINS-0.1.4/rATTAINS/NAMESPACE | 9 rATTAINS-0.1.4/rATTAINS/NEWS.md | 5 rATTAINS-0.1.4/rATTAINS/R/actions.R | 63 - rATTAINS-0.1.4/rATTAINS/R/assessment_units.R | 40 rATTAINS-0.1.4/rATTAINS/R/assessments.R | 68 - rATTAINS-0.1.4/rATTAINS/R/domain_values.R | 37 rATTAINS-0.1.4/rATTAINS/R/huc12_summary.R | 65 - rATTAINS-0.1.4/rATTAINS/R/internal.R | 30 rATTAINS-0.1.4/rATTAINS/R/plans.R | 77 - rATTAINS-0.1.4/rATTAINS/R/state_summary.R | 45 rATTAINS-0.1.4/rATTAINS/R/survey.R | 52 rATTAINS-0.1.4/rATTAINS/README.md | 236 +--- rATTAINS-0.1.4/rATTAINS/build/vignette.rds |binary rATTAINS-0.1.4/rATTAINS/inst/CITATION | 4 rATTAINS-0.1.4/rATTAINS/inst/doc/Introduction.R | 18 rATTAINS-0.1.4/rATTAINS/inst/doc/Introduction.Rmd | 34 rATTAINS-0.1.4/rATTAINS/inst/doc/Introduction.html | 578 +++++++--- rATTAINS-0.1.4/rATTAINS/man/actions.Rd | 5 rATTAINS-0.1.4/rATTAINS/man/assessment_units.Rd | 5 rATTAINS-0.1.4/rATTAINS/man/assessments.Rd | 5 rATTAINS-0.1.4/rATTAINS/man/domain_values.Rd | 3 rATTAINS-0.1.4/rATTAINS/man/huc12_summary.Rd | 5 rATTAINS-0.1.4/rATTAINS/man/plans.Rd | 5 rATTAINS-0.1.4/rATTAINS/man/state_summary.Rd | 5 rATTAINS-0.1.4/rATTAINS/man/surveys.Rd | 5 rATTAINS-0.1.4/rATTAINS/tests/files |only rATTAINS-0.1.4/rATTAINS/tests/fixtures/state_summary.yml | 10 rATTAINS-0.1.4/rATTAINS/tests/testthat/test-actions.R | 32 rATTAINS-0.1.4/rATTAINS/tests/testthat/test-assessment_units.R | 30 rATTAINS-0.1.4/rATTAINS/tests/testthat/test-assessments.R | 27 rATTAINS-0.1.4/rATTAINS/tests/testthat/test-domain_values.R | 28 rATTAINS-0.1.4/rATTAINS/tests/testthat/test-huc12_summary.R | 27 rATTAINS-0.1.4/rATTAINS/tests/testthat/test-plans.R | 27 rATTAINS-0.1.4/rATTAINS/tests/testthat/test-state_summary.R | 28 rATTAINS-0.1.4/rATTAINS/tests/testthat/test-survey.R | 27 rATTAINS-0.1.4/rATTAINS/vignettes/Introduction.Rmd | 34 43 files changed, 732 insertions(+), 1032 deletions(-)
Title: Versatile Curation of Table Metadata
Description: A YAML-based
mechanism for working with table metadata. Supports
compact syntax for creating, modifying, viewing, exporting,
importing, displaying, and plotting metadata coded as column
attributes. The 'yamlet' dialect is valid 'YAML' with
defaults and conventions chosen to improve readability.
See ?yamlet, ?decorate.data.frame and ?modify.default.
See ?read_yamlet ?write_yamlet, ?io_csv, and ?ggplot.decorated.
Author: Tim Bergsma
Maintainer: Tim Bergsma <bergsmat@gmail.com>
Diff between yamlet versions 0.10.0 dated 2022-11-23 and 0.10.8 dated 2023-01-10
DESCRIPTION | 6 MD5 | 84 +++--- NAMESPACE | 1 R/append_units.R | 7 R/classified.R | 14 + R/dvec.R | 48 +++ R/ggplot.R | 49 +-- R/vec_cast.R | 22 - R/vec_ptype2.R | 41 +-- R/yamlet_options.R | 7 inst/doc/yamlet-introduction.html | 4 man/as_dvec.numeric.Rd | 3 man/as_units.dvec.Rd | 4 man/is_dvec.Rd |only man/reconcile.list.Rd | 13 - man/vec_cast.character.dvec.Rd | 2 man/vec_cast.complex.dvec.Rd | 2 man/vec_cast.double.dvec.Rd | 2 man/vec_cast.dvec.character.Rd | 2 man/vec_cast.dvec.complex.Rd | 2 man/vec_cast.dvec.double.Rd | 2 man/vec_cast.dvec.dvec.Rd | 2 man/vec_cast.dvec.integer.Rd | 2 man/vec_cast.dvec.logical.Rd | 2 man/vec_cast.integer.dvec.Rd | 2 man/vec_cast.logical.dvec.Rd | 2 man/vec_ptype2.character.dvec.Rd | 2 man/vec_ptype2.complex.dvec.Rd | 2 man/vec_ptype2.double.dvec.Rd | 2 man/vec_ptype2.dvec.character.Rd | 2 man/vec_ptype2.dvec.complex.Rd | 2 man/vec_ptype2.dvec.double.Rd | 11 man/vec_ptype2.dvec.dvec.Rd | 2 man/vec_ptype2.dvec.integer.Rd | 2 man/vec_ptype2.dvec.logical.Rd | 2 man/vec_ptype2.integer.dvec.Rd | 2 man/vec_ptype2.logical.dvec.Rd | 2 man/yamlet_options.Rd | 5 tests/testthat/111.rds |binary tests/testthat/113.rds |binary tests/testthat/117.rds |only tests/testthat/Rplots.pdf |binary tests/testthat/test-dvec.R | 481 ++++++++++++++++++++++++++++++-------- tests/testthat/test-yamlet.R | 39 ++- 44 files changed, 652 insertions(+), 229 deletions(-)
Title: Support for Orientation Data
Description: Representations, conversions and display of orientation SO(3) data.
See the orientlib help topic for details.
Author: Duncan Murdoch
Maintainer: Duncan Murdoch <murdoch.duncan@gmail.com>
Diff between orientlib versions 0.10.4 dated 2020-05-26 and 0.10.5 dated 2023-01-10
DESCRIPTION | 9 +++++--- MD5 | 13 ++++++------ NEWS | 5 ++++ R/boats.r | 8 +++---- README.md |only inst/doc/orientlib_paper.pdf |binary man/boat3d.Rd | 4 +-- man/orientlib.Rd | 45 ------------------------------------------- 8 files changed, 24 insertions(+), 60 deletions(-)
Title: Ordinal Causal Discovery
Description: Algorithms for ordinal causal discovery. This package aims to enable users to discover causality for observational ordinal categorical data with greedy and exhaustive search. See Ni, Y., & Mallick, B. (2022) <https://proceedings.mlr.press/v180/ni22a/ni22a.pdf> "Ordinal Causal Discovery. Proceedings of the 38th Conference on Uncertainty in Artificial Intelligence, (UAI 2022), PMLR 180:1530–1540".
Author: Yang Ni [aut, cre]
Maintainer: Yang Ni <yni@stat.tamu.edu>
Diff between OrdCD versions 1.0.0 dated 2022-09-27 and 1.1.0 dated 2023-01-10
OrdCD-1.0.0/OrdCD/R/functions_v2.R |only OrdCD-1.1.0/OrdCD/DESCRIPTION | 12 ++++++------ OrdCD-1.1.0/OrdCD/MD5 | 7 ++++--- OrdCD-1.1.0/OrdCD/R/functions_v3.R |only OrdCD-1.1.0/OrdCD/README.md |only OrdCD-1.1.0/OrdCD/man/OCD.Rd | 18 ++++++++++++++---- 6 files changed, 24 insertions(+), 13 deletions(-)
Title: Ethnicity Annotation from Whole-Exome and Targeted Sequencing
Data
Description: Reliable and rapid ethnicity annotation from whole exome and targeted sequencing data.
Author: Alessandro Romanel [aut, cre],
Davide Dalfovo [aut]
Maintainer: Alessandro Romanel <alessandro.romanel@unitn.it>
Diff between EthSEQ versions 3.0.0 dated 2022-09-14 and 3.0.1 dated 2023-01-10
DESCRIPTION | 6 ++--- MD5 | 12 +++++----- R/ethseq_Analysis.R | 6 ++--- R/ethseq_RM.R | 4 +-- inst/doc/EthSEQ.html | 42 +++++++++++++++++------------------ inst/extdata/Annotations_Test_v3.txt | 2 - man/ethseq.Analysis.Rd | 6 ++--- 7 files changed, 39 insertions(+), 39 deletions(-)
Title: Assertion and Message Functions
Description: Enhanced message functions (cat() / message() / warning() / error())
using wrappers around sprintf(). Also, multiple assertion functions
(e.g. to check class, length, values, files, arguments, etc.).
Author: Florian Prive [aut, cre]
Maintainer: Florian Prive <florian.prive.21@gmail.com>
Diff between bigassertr versions 0.1.5 dated 2021-07-08 and 0.1.6 dated 2023-01-10
DESCRIPTION | 10 - MD5 | 14 - NAMESPACE | 1 R/assert.R | 22 +++ README.md | 9 - man/assert.Rd | 304 ++++++++++++++++++++++--------------------- man/bigassertr-package.Rd | 48 +++--- tests/testthat/test-assert.R | 9 + 8 files changed, 229 insertions(+), 188 deletions(-)
Title: Read 'Bibtex' Files and Convert Between Bibliography Formats
Description: Read and write 'Bibtex' files. Convert between bibliography
formats, including 'Bibtex', 'Biblatex', 'PubMed', 'Endnote', and
'Bibentry'. Includes a port of the 'bibutils' utilities by Chris
Putnam <https://sourceforge.net/projects/bibutils/>. Supports all
bibliography formats and character encodings implemented in
'bibutils'.
Author: Georgi N. Boshnakov [aut, cre] ),
Chris Putman [aut] ,
Richard Mathar [ctb] ,
Johannes Wilm [ctb]
Maintainer: Georgi N. Boshnakov <georgi.boshnakov@manchester.ac.uk>
Diff between rbibutils versions 2.2.11 dated 2022-12-08 and 2.2.12 dated 2023-01-10
rbibutils-2.2.11/rbibutils/src/adsout_journals.c |only rbibutils-2.2.12/rbibutils/DESCRIPTION | 6 rbibutils-2.2.12/rbibutils/MD5 | 65 rbibutils-2.2.12/rbibutils/NEWS.md | 13 rbibutils-2.2.12/rbibutils/R/bib.R | 2 rbibutils-2.2.12/rbibutils/R/convert.R | 4 rbibutils-2.2.12/rbibutils/R/sysdata.rda |binary rbibutils-2.2.12/rbibutils/build/partial.rdb |binary rbibutils-2.2.12/rbibutils/inst/bib/texChars.bib | 9 rbibutils-2.2.12/rbibutils/src/adsout.c | 71 rbibutils-2.2.12/rbibutils/src/any2xml.c | 4 rbibutils-2.2.12/rbibutils/src/bib2be.c | 4 rbibutils-2.2.12/rbibutils/src/bibcore.c | 2 rbibutils-2.2.12/rbibutils/src/bibentrydirectout.c | 1050 ---------- rbibutils-2.2.12/rbibutils/src/bibentryout.c | 780 ------- rbibutils-2.2.12/rbibutils/src/biblatexin.c | 459 ---- rbibutils-2.2.12/rbibutils/src/biblatexout.c | 666 ------ rbibutils-2.2.12/rbibutils/src/bibtexdirectin.c | 958 --------- rbibutils-2.2.12/rbibutils/src/bibtexin.c | 881 -------- rbibutils-2.2.12/rbibutils/src/bibtexout.c | 657 ------ rbibutils-2.2.12/rbibutils/src/common_be_bed.c |only rbibutils-2.2.12/rbibutils/src/common_beout.h |only rbibutils-2.2.12/rbibutils/src/common_bt_blt_btd_out.c |only rbibutils-2.2.12/rbibutils/src/common_bt_blt_btd_out.h |only rbibutils-2.2.12/rbibutils/src/common_bt_btd.c |only rbibutils-2.2.12/rbibutils/src/common_bt_btd.h |only rbibutils-2.2.12/rbibutils/src/common_bt_btd_blt.c |only rbibutils-2.2.12/rbibutils/src/common_bt_btd_blt.h |only rbibutils-2.2.12/rbibutils/src/common_bt_btd_out.c |only rbibutils-2.2.12/rbibutils/src/common_bt_btd_out.h |only rbibutils-2.2.12/rbibutils/src/endin.c | 2 rbibutils-2.2.12/rbibutils/src/name.c | 6 rbibutils-2.2.12/rbibutils/src/name.h | 2 rbibutils-2.2.12/rbibutils/src/str_conv.c | 2 rbibutils-2.2.12/rbibutils/src/tomods.c | 16 rbibutils-2.2.12/rbibutils/src/xml2any.c | 48 rbibutils-2.2.12/rbibutils/tests/testthat/texChars_converted.rds |binary rbibutils-2.2.12/rbibutils/tests/testthat/texChars_exported.rds |binary rbibutils-2.2.12/rbibutils/tests/testthat/texChars_kept.rds |binary 39 files changed, 331 insertions(+), 5376 deletions(-)
Title: Projection Predictive Feature Selection
Description: Performs projection predictive feature selection for generalized linear and
additive models as well as for generalized linear and additive multilevel
models (see Piironen, Paasiniemi and Vehtari, 2020,
<doi:10.1214/20-EJS1711>; Catalina, Bürkner and Vehtari, 2022,
<https://proceedings.mlr.press/v151/catalina22a.html>). The package is
compatible with the 'rstanarm' and 'brms' packages, but other reference
models can also be used. See the documentation as well as the package
vignette for more information and examples.
Author: Juho Piironen [aut],
Markus Paasiniemi [aut],
Alejandro Catalina [aut],
Frank Weber [cre, aut],
Aki Vehtari [aut],
Jonah Gabry [ctb],
Marco Colombo [ctb],
Paul-Christian Buerkner [ctb],
Hamada S. Badr [ctb],
Brian Sullivan [ctb],
Soelvi Roegnvaldsson [c [...truncated...]
Maintainer: Frank Weber <fweber144@protonmail.com>
Diff between projpred versions 2.2.2 dated 2022-11-09 and 2.3.0 dated 2023-01-10
DESCRIPTION | 10 ++-- MD5 | 38 ++++++++--------- NEWS.md | 12 +++++ R/cv_varsel.R | 4 - R/extend_family.R | 83 +++++++++++++++++++++++++++------------ R/methods.R | 48 +++++++++++----------- R/project.R | 9 ++-- R/projfun.R | 6 +- R/refmodel.R | 16 ++++--- R/search.R | 2 R/varsel.R | 2 README.md | 68 +++++++++++++++++++------------ inst/doc/projpred.html | 6 +- man/plot.vsel.Rd | 12 ++--- man/project.Rd | 9 ++-- man/refmodel-init-get.Rd | 16 ++++--- man/suggest_size.Rd | 15 +++---- man/summary.vsel.Rd | 12 ++--- tests/testthat/helpers/testers.R | 48 +++++++--------------- tests/testthat/setup.R | 6 +- 20 files changed, 240 insertions(+), 182 deletions(-)
Title: 'Rcpp' Bindings to Parser for "Tom's Obvious Markup Language"
Description: The configuration format defined by 'TOML' (which expands to
"Tom's Obvious Markup Language") specifies an excellent format
(described at <https://toml.io/en/>) suitable for both human editing
as well as the common uses of a machine-readable format. This package
uses 'Rcpp' to connect the 'cpptoml' parser written by Chase Geigle
(in C++11) to R.
Author: Dirk Eddelbuettel
Maintainer: Dirk Eddelbuettel <edd@debian.org>
Diff between RcppTOML versions 0.1.7 dated 2020-12-02 and 0.2.0 dated 2023-01-10
RcppTOML-0.1.7/RcppTOML/inst/include/cpptoml.h |only RcppTOML-0.1.7/RcppTOML/inst/include/includize.hpp |only RcppTOML-0.1.7/RcppTOML/inst/include/toml.hpp |only RcppTOML-0.1.7/RcppTOML/src/Makevars.win |only RcppTOML-0.2.0/RcppTOML/ChangeLog | 53 + RcppTOML-0.2.0/RcppTOML/DESCRIPTION | 10 RcppTOML-0.2.0/RcppTOML/MD5 | 79 +- RcppTOML-0.2.0/RcppTOML/R/RcppExports.R | 5 RcppTOML-0.2.0/RcppTOML/R/parseToml.R | 51 + RcppTOML-0.2.0/RcppTOML/README.md | 47 - RcppTOML-0.2.0/RcppTOML/inst/NEWS.Rd | 15 RcppTOML-0.2.0/RcppTOML/inst/include/toml++ |only RcppTOML-0.2.0/RcppTOML/inst/tinytest/bool_datetime.toml | 12 RcppTOML-0.2.0/RcppTOML/inst/tinytest/test_bool_datetime.R | 10 RcppTOML-0.2.0/RcppTOML/man/parseTOML.Rd | 109 +-- RcppTOML-0.2.0/RcppTOML/src/Makevars | 7 RcppTOML-0.2.0/RcppTOML/src/RcppExports.cpp | 15 RcppTOML-0.2.0/RcppTOML/src/parse.cpp | 418 +++---------- RcppTOML-0.2.0/RcppTOML/src/parse.h |only 19 files changed, 374 insertions(+), 457 deletions(-)
Title: Functional Programming Tools
Description: A complete and consistent functional programming toolkit for
R.
Author: Hadley Wickham [aut, cre] ,
Lionel Henry [aut],
RStudio [cph, fnd]
Maintainer: Hadley Wickham <hadley@rstudio.com>
Diff between purrr versions 1.0.0 dated 2022-12-20 and 1.0.1 dated 2023-01-10
DESCRIPTION | 19 +++++++------ MD5 | 59 +++++++++++++++++++++++-------------------- NEWS.md | 21 +++++++++++++++ R/adverb-safely.R | 2 - R/cleancall.R |only R/deprec-lift.R | 2 - R/deprec-when.R | 6 ++-- R/map.R | 34 +++++++++++++++++++++--- R/map2.R | 3 +- R/pluck.R | 8 ++--- R/pmap.R | 3 +- R/progress-bars.R | 6 ++-- man/auto_browse.Rd | 2 - man/insistently.Rd | 2 - man/lift.Rd | 2 - man/map.Rd | 3 ++ man/map2.Rd | 3 ++ man/pmap.Rd | 3 ++ man/possibly.Rd | 2 - man/progress_bars.Rd | 6 ++-- man/purrr-package.Rd | 4 +- man/purrr_error_indexed.Rd |only man/quietly.Rd | 2 - man/rmd |only man/safely.Rd | 2 - man/slowly.Rd | 2 - man/when.Rd | 6 ++-- src/cleancall.c |only src/cleancall.h |only src/init.c | 8 ++++- src/map.c | 18 ++++++++++--- tests/testthat/_snaps/map.md | 26 ++++++++++++++++-- tests/testthat/test-map.R | 25 ++++++++++++++++-- 33 files changed, 197 insertions(+), 82 deletions(-)
Title: Apply a Function to a Margin of an Array
Description: High performance variant of apply() for a fixed set of functions.
Considerable speedup of this implementation is a trade-off for universality: user defined
functions cannot be used with this package. However, about 20 most currently employed
functions are available for usage. They can be divided in three types:
reducing functions (like mean(), sum() etc., giving a scalar when applied to a vector),
mapping function (like normalise(), cumsum() etc., giving a vector of the same length
as the input vector) and finally, vector reducing function (like diff() which produces
result vector of a length different from the length of input vector).
Optional or mandatory additional arguments required by some functions
(e.g. norm type for norm()) can be
passed as named arguments in '...'.
Author: Serguei Sokol
Maintainer: Serguei Sokol <sokol@insa-toulouse.fr>
Diff between arrApply versions 2.1 dated 2019-03-08 and 2.2 dated 2023-01-10
DESCRIPTION | 16 +-- MD5 | 14 +- NEWS | 11 ++ R/RcppExports.R | 82 +++++++++++----- man/arrApply.Rd | 84 +++++++++++------ src/RcppExports.cpp | 5 + src/arrApply.cpp | 201 ++++++++++++++++++++++++++++------------- tests/testthat/test_arrApply.R | 5 - 8 files changed, 291 insertions(+), 127 deletions(-)
Title: Regression Analysis Linear and Nonlinear for Agriculture
Description: Linear and nonlinear regression analysis common in agricultural science articles (Archontoulis & Miguez (2015). <doi:10.2134/agronj2012.0506>). The package includes polynomial, exponential, gaussian, logistic, logarithmic, segmented, non-parametric models, among others. The functions return the model coefficients and their respective p values, coefficient of determination, root mean square error, AIC, BIC, as well as graphs with the equations automatically.
Author: Gabriel Danilo Shimizu [aut, cre]
,
Leandro Simoes Azeredo Goncalves [aut, ctb]
Maintainer: Gabriel Danilo Shimizu <shimizu@uel.br>
Diff between AgroReg versions 1.2.7 dated 2022-10-19 and 1.2.8 dated 2023-01-10
DESCRIPTION | 15 +++-- MD5 | 110 +++++++++++++++++++++--------------------- NAMESPACE | 1 R/AM_analysis.R | 4 - R/BC_analysis.R | 4 - R/BIEXP_analysis.R | 4 - R/CD_analysis.R | 4 - R/LL_analysis.R | 4 - R/LM13_analysis.R | 4 - R/LM13i_analysis.R | 4 - R/LM23_analysis.R | 4 - R/LM23i_analysis.R | 4 - R/LM2i3_analysis.R | 4 - R/LM_analysis.R | 4 - R/LM_i_analysis.R | 4 - R/LNplt_analysis.R | 5 - R/LOG2_analysis.R | 5 + R/LOG_analysis.R | 4 - R/MM_analysis.R | 4 - R/N_analysis.R | 6 +- R/PAGE_analysis.R | 4 - R/SH_function.R | 4 - R/VB_analysis.R | 4 - R/VG_analysis.R | 4 - R/asymptotic_analysis.R | 4 - R/asymptotic_i_analysis.R | 4 - R/asymptotic_i_sup_analysis.R | 4 - R/asymptotic_sup_analysis.R | 4 - R/beta_analysis.R | 4 - R/comparative_function.R | 6 ++ R/gaussian_analysis.R | 5 - R/gompertz_analysis.R | 4 - R/hill_analysis.R | 4 - R/linearlinear_analysis.R | 7 +- R/loess_analysis.R | 6 +- R/logistic_analysis.R | 4 - R/lorentz_analysis.R | 5 - R/midilli_analysis.R | 4 - R/midillim_analysis.R | 4 - R/mitscherlich_analysis.R | 4 - R/newton_analysis.R | 4 - R/peleg_analysis.R | 4 - R/plot_arrange.R | 6 ++ R/pltLN_analysis.R | 10 +-- R/pltQD_analysis.R | 10 +-- R/potential_analysis.R | 4 - R/quadraticplateau_analysis.R | 5 - R/regression.R | 2 R/thompson_analysis.R | 4 - R/valcam_analysis.R | 4 - R/weibull_analysis.R | 4 - R/yieldloss_analysis.R | 7 +- build/partial.rdb |binary man/AgroReg-package.Rd | 2 man/comparative_model.Rd | 6 ++ man/plot_arrange.Rd | 6 ++ 56 files changed, 197 insertions(+), 168 deletions(-)
Title: Metrics for Assessing Segmentation Accuracy for Geospatial Data
Description: A system that computes metrics to assess the segmentation
accuracy of geospatial data. These metrics calculate the discrepancy
between segmented and reference objects, and indicate the segmentation
accuracy. For more details on choosing evaluation metrics, we
suggest seeing Costa et al. (2018) <doi:10.1016/j.rse.2017.11.024> and
Jozdani et al. (2020) <doi:10.1016/j.isprsjprs.2020.01.002>.
Author: Rolf Simoes [aut] ,
Alber Sanchez [aut] ,
Michelle Picoli [aut, cre]
Maintainer: Michelle Picoli <mipicoli@gmail.com>
Diff between segmetric versions 0.2.0 dated 2022-03-30 and 0.3.0 dated 2023-01-10
segmetric-0.2.0/segmetric/inst/extdata |only segmetric-0.2.0/segmetric/man/grapes-greater-than-grapes.Rd |only segmetric-0.3.0/segmetric/DESCRIPTION | 14 segmetric-0.3.0/segmetric/MD5 | 52 - segmetric-0.3.0/segmetric/NAMESPACE | 18 segmetric-0.3.0/segmetric/NEWS.md |only segmetric-0.3.0/segmetric/R/data.R | 2 segmetric-0.3.0/segmetric/R/db.R | 155 ++- segmetric-0.3.0/segmetric/R/functions.R | 83 + segmetric-0.3.0/segmetric/R/metric-funs.R | 181 ++-- segmetric-0.3.0/segmetric/R/segmetric-package.R | 33 segmetric-0.3.0/segmetric/R/segmetric.R | 120 ++ segmetric-0.3.0/segmetric/R/zzz.R | 18 segmetric-0.3.0/segmetric/README.md | 50 - segmetric-0.3.0/segmetric/build/partial.rdb |binary segmetric-0.3.0/segmetric/demo/demo1.R | 16 segmetric-0.3.0/segmetric/demo/demo2.R | 58 - segmetric-0.3.0/segmetric/inst/CITATION |only segmetric-0.3.0/segmetric/man/db_functions.Rd | 3 segmetric-0.3.0/segmetric/man/figures |only segmetric-0.3.0/segmetric/man/general_functions.Rd | 33 segmetric-0.3.0/segmetric/man/metric_functions.Rd | 12 segmetric-0.3.0/segmetric/man/plot.Rd | 18 segmetric-0.3.0/segmetric/man/reexports.Rd |only segmetric-0.3.0/segmetric/man/seg_sf.Rd | 2 segmetric-0.3.0/segmetric/man/segmetric-package.Rd | 41 segmetric-0.3.0/segmetric/man/segmetric_functions.Rd | 10 segmetric-0.3.0/segmetric/tests/testthat/segmetric_util.R | 113 +- segmetric-0.3.0/segmetric/tests/testthat/test-db.R | 535 ++++++------ 29 files changed, 1059 insertions(+), 508 deletions(-)
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-12-22 0.2.2
2022-12-16 0.2.1
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-12-07 0.0.2
2022-05-27 0.0.1
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2019-12-11 1.2.4
2019-01-08 1.2.3
2018-05-02 1.2.2
2018-03-01 1.2.1
2017-09-28 1.2.0
2016-10-03 1.1.9
2015-12-21 1.1.8
2015-11-12 1.1.7
2015-04-22 1.1.6
2014-12-01 1.1.5
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-12-20 0.1
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2020-11-30 0.3.2
2020-05-13 0.3.1
2020-04-01 0.3.0
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2020-06-15 0.0.5
2020-02-09 0.0.4
2019-12-17 0.0.3
2018-05-01 0.0.2
2018-01-23 0.0.1
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-02-03 4.0.1
2022-01-31 4.0.0
2020-10-24 3.1.0
2019-10-26 3.0.0
2019-10-09 2.0.0
2019-09-29 1.0.1
2019-09-23 1.0.0
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-12-09 2.3
2022-09-01 2.2
2022-08-20 2.1
2022-07-04 2.0
2022-04-01 1.9
Title: Robust Functional Linear Regression
Description: Functions for implementing robust methods for functional linear regression. In the functional linear regression, we consider scalar-on-function linear regression and function-on-function linear regression. More details, see Beyaztas, U., and Shang, H. L. (2021) <arXiv:2111.01238> and Beyaztas, U., and Shang, H. L. (2022) <arXiv:2203.05065>.
Author: Ufuk Beyaztas [aut, cre, cph] ,
Han Lin Shang [aut]
Maintainer: Ufuk Beyaztas <ufukbeyaztas@gmail.com>
Diff between robflreg versions 1.0 dated 2022-05-12 and 1.1 dated 2023-01-10
ChangeLog |only DESCRIPTION | 10 MD5 | 65 - NAMESPACE | 3 R/generate.ff.data.R | 52 + R/generate.sf.data.R | 56 + R/get.ff.coeffs.R | 12 R/get.sf.coeffs.R | 13 R/getPCA.R | 18 R/getPCA.test.R | 13 R/plot_ff_coeffs.R | 29 R/plot_sf_coeffs.R | 3 R/predict_ff_regression.R | 24 R/predict_sf_regression.R | 58 - R/rob.ff.reg.R | 71 - R/rob.sf.reg.R | 258 +++-- R/var.sel.R | 13 data |only inst/doc/robflreg.pdf |binary man/MaryRiverFlow.Rd |only man/generate.ff.data.Rd | 20 man/generate.sf.data.Rd | 24 man/get.sf.coeffs.Rd | 3 man/getPCA.Rd | 11 man/getPCA.test.Rd | 16 man/plot_ff_coeffs.Rd | 15 man/predict_ff_regression.Rd | 25 man/predict_sf_regression.Rd | 32 man/rob.ff.reg.Rd | 168 +-- man/rob.out.detect.Rd | 12 man/rob.sf.reg.Rd | 17 man/robflreg-package.Rd | 16 vignettes/master.bib | 80 + vignettes/robflreg-020.pdf |only vignettes/robflreg-021.pdf |only vignettes/robflreg.Rnw | 1956 +++++++++++++++++++++---------------------- 36 files changed, 1674 insertions(+), 1419 deletions(-)
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-12-05 0.1.0
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-12-08 1.0.0
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2020-06-03 0.0.1
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-12-05 2.0.0
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-12-12 0.1.5
2022-12-09 0.1.4
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-11-22 1.0.7
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-01-07 0.0.1
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-08-30 1.0.1
2022-08-09 1.0.0
2022-06-15 0.2.3
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2023-01-06 0.0.6
2022-12-14 0.0.5
2022-11-07 0.0.4
2022-10-09 0.0.3
2022-09-05 0.0.2
2022-08-23 0.0.1
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2018-05-22 1.4.1
2017-09-25 1.4
2017-01-16 1.3
2014-12-09 1.2.4
2014-09-04 1.2.3
2014-01-08 1.2.2
2011-05-02 1.2.1
2010-11-29 1.2
2010-02-11 1.1
2009-11-29 1.0
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2021-08-22 0.31
2021-05-14 0.30
2021-02-16 0.21
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-10-04 1.0.0
2022-08-30 0.3.4
2022-06-13 0.3.3
2022-05-31 0.3.2
2021-09-01 0.3.1
2021-07-30 0.3.0
2021-02-25 0.2.2
2020-02-20 0.2.1
2020-01-15 0.2.0
2019-08-05 0.1.0
Title: An 'SVG' Graphics Device
Description: A graphics device for R that produces 'Scalable Vector
Graphics'. 'svglite' is a fork of the older 'RSvgDevice' package.
Author: Hadley Wickham [aut],
Lionel Henry [aut],
Thomas Lin Pedersen [cre, aut]
,
T Jake Luciani [aut],
Matthieu Decorde [aut],
Vaudor Lise [aut],
Tony Plate [ctb] ,
David Gohel [ctb] ,
Yixuan Qiu [ctb] ,
Hakon Malmedal [ctb] ,
RStudio [cph, fnd]
Maintainer: Thomas Lin Pedersen <thomas.pedersen@posit.co>
Diff between svglite versions 2.1.0 dated 2022-02-03 and 2.1.1 dated 2023-01-10
svglite-2.1.0/svglite/vignettes/releases |only svglite-2.1.1/svglite/DESCRIPTION | 58 ++- svglite-2.1.1/svglite/MD5 | 29 - svglite-2.1.1/svglite/NEWS.md | 4 svglite-2.1.1/svglite/R/SVG.R | 2 svglite-2.1.1/svglite/build/vignette.rds |binary svglite-2.1.1/svglite/inst/doc/fonts.Rmd | 2 svglite-2.1.1/svglite/inst/doc/fonts.html | 381 ++++++++++++++++++++---- svglite-2.1.1/svglite/inst/doc/scaling.html | 435 +++++++++++++++++++++++----- svglite-2.1.1/svglite/man/editSVG.Rd | 4 svglite-2.1.1/svglite/man/svglite.Rd | 6 svglite-2.1.1/svglite/man/svgstring.Rd | 8 svglite-2.1.1/svglite/man/xmlSVG.Rd | 4 svglite-2.1.1/svglite/src/devSVG.cpp | 19 - svglite-2.1.1/svglite/src/utils.h | 2 svglite-2.1.1/svglite/vignettes/fonts.Rmd | 2 16 files changed, 739 insertions(+), 217 deletions(-)
Title: Estimating Hierarchical Linear Models for Single-Case Designs
Description: Provides a set of tools for estimating hierarchical linear
models and effect sizes based on data from single-case designs.
Functions are provided for calculating standardized mean difference effect sizes that
are directly comparable to standardized mean differences estimated from between-subjects randomized experiments,
as described in Hedges, Pustejovsky, and Shadish (2012) <DOI:10.1002/jrsm.1052>;
Hedges, Pustejovsky, and Shadish (2013) <DOI:10.1002/jrsm.1086>; and
Pustejovsky, Hedges, and Shadish (2014) <DOI:10.3102/1076998614547577>.
Includes an interactive web interface.
Author: James Pustejovsky [aut, cre],
Man Chen [aut],
Bethany Hamilton [aut]
Maintainer: James Pustejovsky <jepusto@gmail.com>
Diff between scdhlm versions 0.7.0 dated 2022-11-07 and 0.7.1 dated 2023-01-10
DESCRIPTION | 8 +- MD5 | 18 +++--- NEWS.md | 4 + build/partial.rdb |binary build/vignette.rds |binary inst/doc/Estimating-effect-sizes.html | 4 - inst/shiny-examples/scdhlm/markdown/demos.md | 4 - inst/shiny-examples/scdhlm/markdown/scdhlm.md | 6 +- inst/shiny-examples/scdhlm/rsconnect/shinyapps.io/jepusto/scdhlm.dcf | 6 +- tests/testthat/test-calc_BCSMD.R | 27 ++++++++-- 10 files changed, 49 insertions(+), 28 deletions(-)
Title: Approximate POMDP Planning Software
Description: A toolkit for Partially Observed Markov Decision Processes (POMDP). Provides
bindings to C++ libraries implementing the algorithm SARSOP (Successive Approximations
of the Reachable Space under Optimal Policies) and described in Kurniawati et al (2008),
<doi:10.15607/RSS.2008.IV.009>. This package also provides a high-level interface
for generating, solving and simulating POMDP problems and their solutions.
Author: Carl Boettiger [cre, aut, cph]
,
Jeroen Ooms [aut],
Milad Memarzadeh [aut],
Hanna Kurniawati [ctb, cph],
David Hsu [ctb, cph],
Hanna Kurniawati [ctb, cph],
Wee Sun Lee [ctb, cph],
Yanzhu Du [ctb],
Xan Huang [ctb],
Trey Smith [ctb, cph],
Tony Cassandr [...truncated...]
Maintainer: Carl Boettiger <cboettig@gmail.com>
Diff between sarsop versions 0.6.13 dated 2022-10-19 and 0.6.14 dated 2023-01-10
DESCRIPTION | 6 - MD5 | 12 +-- NEWS.md | 4 + src/appl-0.96/Algorithms/SARSOP/BinManager.cpp | 52 ++++++++------- src/appl-0.96/Parser/Cassandra/include/pomdp_spec.tab.cc | 4 - src/appl-0.96/Parser/POMDPX/FactoredPomdp.cpp | 6 - src/appl-0.96/Parser/POMDPX/tinyxml.cpp | 6 - 7 files changed, 49 insertions(+), 41 deletions(-)
Title: Functions for University of Auckland Course STATS 201/208 Data
Analysis
Description: A set of functions used in teaching STATS 201/208 Data Analysis at
the University of Auckland. The functions are designed to make parts of R more
accessible to a large undergraduate population who are mostly not statistics
majors.
Author: Brant Deppa [aut] ,
James Curran [aut, cre] ,
Rachel Fewster [ctb],
Russell Millar [ctb],
Ben Stevenson [ctb],
Andrew Balemi [ctb],
Chris Wild [ctb],
Sophie Jones [ctb],
Dineika Chandra [ctr],
Brendan McArdle [ctr]
Maintainer: James Curran <j.curran@auckland.ac.nz>
Diff between s20x versions 3.1-33 dated 2022-12-23 and 3.1-34 dated 2023-01-10
DESCRIPTION | 12 +++++++++--- MD5 | 6 ++++-- NAMESPACE | 1 + R/displayPairs.R |only man/displayPairs.Rd |only 5 files changed, 14 insertions(+), 5 deletions(-)
Title: PCA on the Torus via Density Ridges
Description: Implementation of a Principal Component Analysis (PCA) in the
torus via density ridge estimation. The main function, ridge_pca(), obtains
the relevant density ridge for bivariate sine von Mises and bivariate
wrapped Cauchy distribution models and provides the associated scores and
variance decomposition. Auxiliary functions for evaluating, fitting, and
sampling these models are also provided. The package provides replicability
to García-Portugués and Prieto-Tirado (2022) <arXiv:2212.10856>.
Author: Eduardo Garcia-Portugues [aut, cre]
,
Arturo Prieto-Tirado [aut]
Maintainer: Eduardo Garcia-Portugues <edgarcia@est-econ.uc3m.es>
Diff between ridgetorus versions 1.0.0 dated 2022-12-23 and 1.0.1 dated 2023-01-10
DESCRIPTION | 8 ++++---- MD5 | 16 ++++++++-------- NEWS.md | 4 ++++ R/BWC.R | 4 ++++ R/RcppExports.R | 2 +- R/ridges-distr.R | 37 ++++++++++++++++++++++++------------- inst/doc/ridgetorus.html | 6 +++--- src/implicit-eq.cpp | 23 +++++++++++++++-------- tests/testthat/test_ridges.R | 1 + 9 files changed, 64 insertions(+), 37 deletions(-)
Title: Fast Fixed-Effects Estimations
Description: Fast and user-friendly estimation of econometric models with multiple fixed-effects. Includes ordinary least squares (OLS), generalized linear models (GLM) and the negative binomial.
The core of the package is based on optimized parallel C++ code, scaling especially well for large data sets. The method to obtain the fixed-effects coefficients is based on Berge (2018) <https://wwwen.uni.lu/content/download/110162/1299525/file/2018_13>.
Further provides tools to export and view the results of several estimations with intuitive design to cluster the standard-errors.
Author: Laurent Berge [aut, cre],
Sebastian Krantz [ctb],
Grant McDermott [ctb]
Maintainer: Laurent Berge <laurent.berge@u-bordeaux.fr>
Diff between fixest versions 0.11.0 dated 2022-10-19 and 0.11.1 dated 2023-01-10
DESCRIPTION | 6 MD5 | 40 +-- NEWS.md | 11 R/data_tools.R | 14 - build/vignette.rds |binary inst/doc/exporting_tables.html | 219 ++++++++----------- inst/doc/fixest_walkthrough.html | 278 ++++++++++-------------- inst/doc/multiple_estimations.html | 219 ++++++++----------- inst/doc/standard_errors.R | 18 - inst/doc/standard_errors.Rmd | 25 +- inst/doc/standard_errors.html | 423 +++++++++++++++++-------------------- man/bin.Rd | 10 man/coeftable.fixest.Rd | 2 man/coeftable.fixest_multi.Rd | 2 man/confint.fixest_multi.Rd | 108 ++++----- man/ref.Rd | 24 +- man/summary.fixest_multi.Rd | 4 src/demeaning.cpp | 7 src/quf.cpp | 4 src/vcov_related.cpp | 4 vignettes/standard_errors.Rmd | 25 +- 21 files changed, 697 insertions(+), 746 deletions(-)
Title: Efficiency Analysis Trees
Description: Functions are provided to determine production frontiers and technical
efficiency measures through non-parametric techniques based upon regression trees.
The package includes code for estimating radial input, output, directional and
additive measures, plotting graphical representations of the scores and the production
frontiers by means of trees, and determining rankings of importance of input variables
in the analysis. Additionally, an adaptation of Random Forest by a set of individual
Efficiency Analysis Trees for estimating technical efficiency is also included. More
details in: <doi:10.1016/j.eswa.2020.113783>.
Author: Miriam Esteve [cre, aut] ,
Victor Espana [aut] ,
Juan Aparicio [aut] ,
Xavier Barber [aut]
Maintainer: Miriam Esteve <mestevecampello@gmail.com>
Diff between eat versions 0.1.3 dated 2022-08-15 and 0.1.4 dated 2023-01-10
DESCRIPTION | 6 +- MD5 | 10 ++-- R/efficiencyEAT.R | 7 ++ build/partial.rdb |binary build/vignette.rds |binary inst/doc/EAT.html | 131 ++++++++++++++++++++++++++--------------------------- 6 files changed, 80 insertions(+), 74 deletions(-)
Title: Cox Mixed-Effects Models for Genome-Wide Association Studies
Description: Fast algorithms for fitting a Cox mixed-effects model for e.g., genome-wide association studies. See Liang He and Alexander Kulminski (2020) <doi: 10.1534/genetics.119.302940>.
Author: Liang He, Stephanie Gogarten
Maintainer: Liang He <lianghe@health.sdu.dk>
Diff between coxmeg versions 1.1.1 dated 2023-01-09 and 1.1.2 dated 2023-01-10
DESCRIPTION | 8 +- MD5 | 14 ++--- build/partial.rdb |binary inst/doc/COXMEG_example.html | 106 +++++++++++++++++++-------------------- inst/doc/coxmeg_gds_example.R | 3 - inst/doc/coxmeg_gds_example.Rmd | 3 - inst/doc/coxmeg_gds_example.html | 10 +-- vignettes/coxmeg_gds_example.Rmd | 3 - 8 files changed, 75 insertions(+), 72 deletions(-)
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2021-11-10 1.4.7
2021-09-02 1.4.6
2021-07-25 1.4.5
2021-07-20 1.4.4
2021-06-12 1.4.3
2021-05-10 1.4.2
2021-04-18 1.4.1
2021-04-13 1.4.0
2021-03-07 1.3.0
2021-02-08 1.2.2
2020-12-16 1.2.1
2020-11-27 1.2.0
2020-11-16 1.1.0
2020-08-17 1.0.0
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2021-09-23 0.1.2
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-09-30 0.1.2
2022-07-21 0.1.1.1
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2021-07-23 0.1.1
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2021-12-10 1.1.3
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2022-10-19 1.2.2
2022-08-14 1.2.1
2021-12-21 1.2.0
2021-09-11 1.1.0
2021-07-20 1.0.0
Title: A Systematic Data Wrangling Idiom
Description: Supports systematic scrutiny, modification, and integration of
data. The function status() counts rows that have missing values in
grouping columns (returned by na() ), have non-unique combinations of
grouping columns (returned by dup() ), and that are not locally sorted
(returned by unsorted() ). Functions enumerate() and itemize() give
sorted unique combinations of columns, with or without occurrence counts,
respectively. Function ignore() drops columns in x that are present in y,
and informative() drops columns in x that are entirely NA; constant() returns
values that are constant, given a key. Data that have defined unique
combinations of grouping values behave more predictably during merge operations.
Author: Tim Bergsma
Maintainer: Tim Bergsma <bergsmat@gmail.com>
Diff between wrangle versions 0.5.8 dated 2023-01-06 and 0.5.10 dated 2023-01-10
DESCRIPTION | 6 +++--- MD5 | 4 ++-- R/wrangle.R | 16 ++++++++++------ 3 files changed, 15 insertions(+), 11 deletions(-)
Title: Importing and Analyzing 'Twitter' Data Collected with 'Twitter
Archiving Google Sheets'
Description: The 'tidytags' package coordinates the simplicity of collecting tweets
over time with a 'Twitter Archiving Google Sheet' (TAGS; <https://tags.hawksey.info/>)
and the utility of the 'rtweet' package (<https://docs.ropensci.org/rtweet/>)
for processing and preparing additional 'Twitter' metadata. 'tidytags' also
introduces functions developed to facilitate systematic yet flexible analyses
of data from 'Twitter'.
Author: K. Bret Staudt Willet [aut, cre]
,
Joshua M. Rosenberg [aut] ,
Lluis Revilla Sancho [rev] ,
Marion Louveaux [rev]
Maintainer: K. Bret Staudt Willet <bret.staudtwillet@fsu.edu>
Diff between tidytags versions 1.1.0 dated 2022-11-18 and 1.1.1 dated 2023-01-10
DESCRIPTION | 10 MD5 | 8 NEWS.md | 9 README.md | 218 ++++----- tests/fixtures/users_info.yml | 993 ++++++++++++++++++------------------------ 5 files changed, 545 insertions(+), 693 deletions(-)
Title: Design Menu for Radiant: Business Analytics using R and Shiny
Description: The Radiant Design menu includes interfaces for design of
experiments, sampling, and sample size calculation. The application extends
the functionality in 'radiant.data'.
Author: Vincent Nijs [aut, cre]
Maintainer: Vincent Nijs <radiant@rady.ucsd.edu>
Diff between radiant.design versions 1.4.4 dated 2022-07-23 and 1.5.0 dated 2023-01-10
DESCRIPTION | 12 ++++---- MD5 | 24 ++++++++-------- NEWS.md | 6 ++-- R/doe.R | 48 ++++++++++++++++---------------- R/randomizer.R | 47 ++++++++++++++++--------------- R/sample_size.R | 17 +++++------ R/sample_size_comp.R | 43 +++++++++++++++------------- R/sampling.R | 26 ++++++++--------- README.md | 6 ++-- inst/app/tools/analysis/doe_ui.R | 47 ++++++++++++++++--------------- inst/app/tools/analysis/randomizer_ui.R | 2 - inst/app/tools/analysis/sampling_ui.R | 4 +- man/estimable.Rd | 1 13 files changed, 148 insertions(+), 135 deletions(-)
More information about radiant.design at CRAN
Permanent link
Title: Basics Menu for Radiant: Business Analytics using R and Shiny
Description: The Radiant Basics menu includes interfaces for probability
calculation, central limit theorem simulation, comparing means and proportions,
goodness-of-fit testing, cross-tabs, and correlation. The application extends
the functionality in 'radiant.data'.
Author: Vincent Nijs [aut, cre]
Maintainer: Vincent Nijs <radiant@rady.ucsd.edu>
Diff between radiant.basics versions 1.4.4 dated 2022-07-23 and 1.5.0 dated 2023-01-10
DESCRIPTION | 16 - MD5 | 68 ++-- NAMESPACE | 1 NEWS.md | 10 R/aaa.R | 4 R/clt.R | 17 - R/compare_means.R | 50 ++- R/compare_props.R | 63 ++-- R/correlation.R | 52 +-- R/cross_tabs.R | 101 +++---- R/goodness.R | 78 +++-- R/prob_calc.R | 403 ++++++++++++++++------------- R/single_mean.R | 60 ++-- R/single_prop.R | 51 +-- README.md | 6 inst/app/tools/analysis/clt_ui.R | 2 inst/app/tools/analysis/compare_means_ui.R | 10 inst/app/tools/analysis/compare_props_ui.R | 10 inst/app/tools/analysis/correlation_ui.R | 16 - inst/app/tools/analysis/cross_tabs_ui.R | 2 inst/app/tools/analysis/goodness_ui.R | 10 inst/app/tools/analysis/prob_calc_ui.R | 20 - inst/app/tools/analysis/single_mean_ui.R | 2 inst/app/tools/analysis/single_prop_ui.R | 2 man/goodness.Rd | 2 man/plot.cross_tabs.Rd | 2 man/plot.goodness.Rd | 2 man/plot.prob_disc.Rd | 2 man/plot.single_prop.Rd | 2 man/prob_disc.Rd | 4 man/single_prop.Rd | 2 man/summary.goodness.Rd | 2 man/summary.prob_disc.Rd | 2 man/summary.single_mean.Rd | 4 man/summary.single_prop.Rd | 2 35 files changed, 582 insertions(+), 498 deletions(-)
More information about radiant.basics at CRAN
Permanent link
Title: Portmanteau Local Feature Discrimination for Matrix-Variate Data
Description: The portmanteau local feature discriminant approach first identifies the local
discriminant features and their differential structures, then constructs the
discriminant rule by pooling the identified local features together. This method
is applicable to high-dimensional matrix-variate data.
See the paper by Xu, Luo and Chen (2021, <doi:10.1007/s13171-021-00255-2>).
Author: Zengchao Xu [aut, cre],
Shan Luo [aut],
Zehua Chen [aut]
Maintainer: Zengchao Xu <zengc.xu@aliyun.com>
Diff between PLFD versions 0.1.1 dated 2021-09-17 and 0.2.0 dated 2023-01-10
PLFD-0.1.1/PLFD/build/partial.rdb |only PLFD-0.1.1/PLFD/inst/doc/PLFD.R |only PLFD-0.1.1/PLFD/inst/doc/PLFD.Rmd |only PLFD-0.1.1/PLFD/inst/doc/PLFD.html |only PLFD-0.1.1/PLFD/vignettes/PLFD.Rmd |only PLFD-0.2.0/PLFD/DESCRIPTION | 24 ++--- PLFD-0.2.0/PLFD/MD5 | 52 +++++------ PLFD-0.2.0/PLFD/NAMESPACE | 1 PLFD-0.2.0/PLFD/NEWS.md | 30 +++++- PLFD-0.2.0/PLFD/R/PLFD-package.R | 1 PLFD-0.2.0/PLFD/R/RcppExports.R | 140 ++++++++++++++++--------------- PLFD-0.2.0/PLFD/R/get-T2.R | 48 +++++----- PLFD-0.2.0/PLFD/R/get-discriminantPara.R | 33 ++++--- PLFD-0.2.0/PLFD/R/get-feature-blocks.R | 38 +++----- PLFD-0.2.0/PLFD/R/get-paras.R | 11 +- PLFD-0.2.0/PLFD/R/get-suppSet.R | 74 ++++++++-------- PLFD-0.2.0/PLFD/R/plfd.R | 69 +++++++-------- PLFD-0.2.0/PLFD/R/predict-plfd.R | 28 +++--- PLFD-0.2.0/PLFD/R/print-plfd.R | 9 + PLFD-0.2.0/PLFD/R/size2blocks.R | 13 +- PLFD-0.2.0/PLFD/README.md | 23 +++-- PLFD-0.2.0/PLFD/build/PLFD.pdf |binary PLFD-0.2.0/PLFD/build/vignette.rds |binary PLFD-0.2.0/PLFD/inst/doc/usage.R |only PLFD-0.2.0/PLFD/inst/doc/usage.Rmd |only PLFD-0.2.0/PLFD/inst/doc/usage.html |only PLFD-0.2.0/PLFD/man/PLFD-package.Rd | 10 -- PLFD-0.2.0/PLFD/man/plfd.Rd | 39 ++++---- PLFD-0.2.0/PLFD/man/predict.plfd.Rd | 3 PLFD-0.2.0/PLFD/man/print.plfd.Rd |only PLFD-0.2.0/PLFD/src/cxxFuns.cpp | 84 +++++++++++------- PLFD-0.2.0/PLFD/vignettes/usage.Rmd |only 32 files changed, 400 insertions(+), 330 deletions(-)
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2023-01-06 1.2.1
2022-08-30 1.2.0
2022-07-01 1.1.0
2022-04-25 1.0.2
2021-12-03 1.0.0
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2021-09-27 1.0.5
Previous versions (as known to CRANberries) which should be available via the Archive link are:
2021-07-11 2.1.7
2020-10-26 2.1.4
2018-01-30 2.1.2
2017-09-22 2.1.0
2017-03-03 2.0.4
2017-01-05 2.0.2
2016-11-18 2.0
Title: An Inclusive, Unifying API for Progress Updates
Description: A minimal, unifying API for scripts and packages to report progress updates from anywhere including when using parallel processing. The package is designed such that the developer can to focus on what progress should be reported on without having to worry about how to present it. The end user has full control of how, where, and when to render these progress updates, e.g. in the terminal using utils::txtProgressBar(), cli::cli_progress_bar(), in a graphical user interface using utils::winProgressBar(), tcltk::tkProgressBar() or shiny::withProgress(), via the speakers using beepr::beep(), or on a file system via the size of a file. Anyone can add additional, customized, progression handlers. The 'progressr' package uses R's condition framework for signaling progress updated. Because of this, progress can be reported from almost anywhere in R, e.g. from classical for and while loops, from map-reduce API:s like the lapply() family of functions, 'purrr', 'plyr', and 'foreach'. It will als [...truncated...]
Author: Henrik Bengtsson [aut, cre, cph]
Maintainer: Henrik Bengtsson <henrikb@braju.com>
Diff between progressr versions 0.12.0 dated 2022-12-13 and 0.13.0 dated 2023-01-10
DESCRIPTION | 8 +- MD5 | 70 +++++++++---------- NAMESPACE | 1 NEWS.md | 45 ++++++++++++ R/global_progression_handler.R | 1 R/handler_ascii_alert.R | 2 R/handler_beepr.R | 11 ++- R/handler_cli.R | 42 +++++++---- R/handler_debug.R | 4 - R/handler_filesize.R | 13 ++- R/handler_notifier.R | 8 +- R/handler_pbmcapply.R | 9 +- R/handler_rpushbullet.R |only R/handler_shiny.R | 14 +++ R/handler_tkprogressbar.R | 10 ++ R/handler_winprogressbar.R | 10 ++ R/handlers.R | 15 +++- R/make_calling_handler.R | 2 R/make_progression_handler.R | 145 +++++++++++++++++++++++++++------------- R/options.R | 4 - inst/doc/progressr-intro.html | 23 ++++++ inst/doc/progressr-intro.md | 37 +++++++++- man/handler_ascii_alert.Rd | 2 man/handler_beepr.Rd | 8 +- man/handler_filesize.Rd | 3 man/handler_rpushbullet.Rd |only man/handler_shiny.Rd | 3 man/make_progression_handler.Rd | 69 ++++++++++++++++++- man/progressr.options.Rd | 4 - tests/handler_cli.R | 2 tests/handler_pbmcapply.R | 2 tests/handler_progress.R | 2 tests/handler_rstudio.R | 2 tests/handler_tkprogressbar.R | 2 tests/handler_txtprogressbar.R | 2 tests/incl/start,load-only.R | 2 vignettes/progressr-intro.md | 37 +++++++++- 37 files changed, 474 insertions(+), 140 deletions(-)
Title: Declare and Diagnose Research Designs
Description: Researchers can characterize and learn about the properties of
research designs before implementation using `DeclareDesign`. Ex ante
declaration and diagnosis of designs can help researchers clarify the
strengths and limitations of their designs and to improve their
properties, and can help readers evaluate a research strategy prior
to implementation and without access to results. It can also make it
easier for designs to be shared, replicated, and critiqued.
Author: Graeme Blair [aut, cre] ,
Jasper Cooper [aut] ,
Alexander Coppock [aut] ,
Macartan Humphreys [aut] ,
Neal Fultz [aut]
Maintainer: Graeme Blair <graeme.blair@gmail.com>
Diff between DeclareDesign versions 1.0.0 dated 2022-06-20 and 1.0.2 dated 2023-01-10
DESCRIPTION | 8 ++++---- MD5 | 10 +++++----- NEWS.md | 4 ++++ R/diagnosis_helper_functions.R | 2 ++ tests/testthat/test-citation.R | 2 +- tests/testthat/test-reshape-diagnosis.R | 13 +++++++++++++ 6 files changed, 29 insertions(+), 10 deletions(-)
Title: Cluster Gauss-Newton Method
Description: Find multiple solutions of a nonlinear least squares problem. Cluster Gauss-Newton method does not assume uniqueness of the solution of the nonlinear least squares problem and compute approximate multiple minimizers. Please cite the following paper when this software is used in your research: Aoki et al. (2020) <doi:10.1007/s11081-020-09571-2>. Cluster Gauss–Newton method. Optimization and Engineering, 1-31.
Author: Yasunori Aoki
Maintainer: Yasunori Aoki <yaoki@uwaterloo.ca>
Diff between CGNM versions 0.5.1 dated 2022-11-01 and 0.6.2 dated 2023-01-10
CGNM-0.5.1/CGNM/vignettes/CGNM_log |only CGNM-0.5.1/CGNM/vignettes/CGNM_log_bootstrap |only CGNM-0.6.2/CGNM/DESCRIPTION | 8 CGNM-0.6.2/CGNM/MD5 | 96 CGNM-0.6.2/CGNM/NAMESPACE | 1 CGNM-0.6.2/CGNM/R/Cluster_Gauss_Newton_method.R | 345 ++- CGNM-0.6.2/CGNM/R/PostProcess.R | 1031 ++++++---- CGNM-0.6.2/CGNM/build/vignette.rds |binary CGNM-0.6.2/CGNM/inst/doc/CGNM-vignette.R | 85 CGNM-0.6.2/CGNM/inst/doc/CGNM-vignette.Rmd | 101 CGNM-0.6.2/CGNM/inst/doc/CGNM-vignette.html | 615 ++++- CGNM-0.6.2/CGNM/man/Cluster_Gauss_Newton_Bootstrap_method.Rd | 7 CGNM-0.6.2/CGNM/man/Cluster_Gauss_Newton_method.Rd | 9 CGNM-0.6.2/CGNM/man/acceptedApproximateMinimizers.Rd | 10 CGNM-0.6.2/CGNM/man/bestApproximateMinimizers.Rd | 11 CGNM-0.6.2/CGNM/man/plot_2DprofileLikelihood.Rd | 15 CGNM-0.6.2/CGNM/man/plot_SSR_parameterValue.Rd | 4 CGNM-0.6.2/CGNM/man/plot_SSRsurface.Rd | 7 CGNM-0.6.2/CGNM/man/plot_goodnessOfFit.Rd | 10 CGNM-0.6.2/CGNM/man/plot_paraDistribution_byHistogram.Rd | 20 CGNM-0.6.2/CGNM/man/plot_paraDistribution_byViolinPlots.Rd | 25 CGNM-0.6.2/CGNM/man/plot_profileLikelihood.Rd | 7 CGNM-0.6.2/CGNM/man/table_parameterSummary.Rd | 20 CGNM-0.6.2/CGNM/man/table_profileLikelihoodConfidenceInterval.Rd |only CGNM-0.6.2/CGNM/vignettes/CGNM-vignette.Rmd | 101 25 files changed, 1817 insertions(+), 711 deletions(-)