Showing 60 of total 60 results (show query)
cran
gaussquad:Collection of Functions for Gaussian Quadrature
A collection of functions to perform Gaussian quadrature with different weight functions corresponding to the orthogonal polynomials in package orthopolynom. Examples verify the orthogonality and inner products of the polynomials.
Maintained by Frederick Novomestky. Last updated 3 years ago.
149.9 match 2.18 score 5 dependentshwborchers
pracma:Practical Numerical Math Functions
Provides a large number of functions from numerical analysis and linear algebra, numerical optimization, differential equations, time series, plus some well-known special mathematical functions. Uses 'MATLAB' function names where appropriate to simplify porting.
Maintained by Hans W. Borchers. Last updated 1 years ago.
25.0 match 29 stars 12.34 score 6.6k scripts 931 dependentsspatstat
spatstat.geom:Geometrical Functionality of the 'spatstat' Family
Defines spatial data types and supports geometrical operations on them. Data types include point patterns, windows (domains), pixel images, line segment patterns, tessellations and hyperframes. Capabilities include creation and manipulation of data (using command line or graphical interaction), plotting, geometrical operations (rotation, shift, rescale, affine transformation), convex hull, discretisation and pixellation, Dirichlet tessellation, Delaunay triangulation, pairwise distances, nearest-neighbour distances, distance transform, morphological operations (erosion, dilation, closing, opening), quadrat counting, geometrical measurement, geometrical covariance, colour maps, calculus on spatial domains, Gaussian blur, level sets of images, transects of images, intersections between objects, minimum distance matching. (Excludes spatial data on a network, which are supported by the package 'spatstat.linnet'.)
Maintained by Adrian Baddeley. Last updated 2 days ago.
classes-and-objectsdistance-calculationgeometrygeometry-processingimagesmensurationplottingpoint-patternsspatial-dataspatial-data-analysis
18.7 match 7 stars 12.11 score 241 scripts 227 dependentsweiserc
mvQuad:Methods for Multivariate Quadrature
Provides methods to construct multivariate grids, which can be used for multivariate quadrature. This grids can be based on different quadrature rules like Newton-Cotes formulas (trapezoidal-, Simpson's- rule, ...) or Gauss quadrature (Gauss-Hermite, Gauss-Legendre, ...). For the construction of the multidimensional grid the product-rule or the combination- technique can be applied.
Maintained by Constantin Weiser. Last updated 9 years ago.
17.6 match 3 stars 6.15 score 45 scripts 7 dependentsnimble-dev
nimble:MCMC, Particle Filtering, and Programmable Hierarchical Modeling
A system for writing hierarchical statistical models largely compatible with 'BUGS' and 'JAGS', writing nimbleFunctions to operate models and do basic R-style math, and compiling both models and nimbleFunctions via custom-generated C++. 'NIMBLE' includes default methods for MCMC, Laplace Approximation, Monte Carlo Expectation Maximization, and some other tools. The nimbleFunction system makes it easy to do things like implement new MCMC samplers from R, customize the assignment of samplers to different parts of a model from R, and compile the new samplers automatically via C++ alongside the samplers 'NIMBLE' provides. 'NIMBLE' extends the 'BUGS'/'JAGS' language by making it extensible: New distributions and functions can be added, including as calls to external compiled code. Although most people think of MCMC as the main goal of the 'BUGS'/'JAGS' language for writing models, one can use 'NIMBLE' for writing arbitrary other kinds of model-generic algorithms as well. A full User Manual is available at <https://r-nimble.org>.
Maintained by Christopher Paciorek. Last updated 5 days ago.
bayesian-inferencebayesian-methodshierarchical-modelsmcmcprobabilistic-programmingopenblascpp
6.9 match 169 stars 12.97 score 2.6k scripts 19 dependentsawblocker
fastGHQuad:Fast 'Rcpp' Implementation of Gauss-Hermite Quadrature
Fast, numerically-stable Gauss-Hermite quadrature rules and utility functions for adaptive GH quadrature. See Liu, Q. and Pierce, D. A. (1994) <doi:10.2307/2337136> for a reference on these methods.
Maintained by Alexander W Blocker. Last updated 3 years ago.
10.7 match 9 stars 8.03 score 57 scripts 69 dependentsstan-dev
rstanarm:Bayesian Applied Regression Modeling via Stan
Estimates previously compiled regression models using the 'rstan' package, which provides the R interface to the Stan C++ library for Bayesian estimation. Users specify models via the customary R syntax with a formula and data.frame plus some additional arguments for priors.
Maintained by Ben Goodrich. Last updated 9 months ago.
bayesianbayesian-data-analysisbayesian-inferencebayesian-methodsbayesian-statisticsmultilevel-modelsrstanrstanarmstanstatistical-modelingcpp
5.4 match 393 stars 15.68 score 5.0k scripts 13 dependentsawstringer1
aghq:Adaptive Gauss Hermite Quadrature for Bayesian Inference
Adaptive Gauss Hermite Quadrature for Bayesian inference. The AGHQ method for normalizing posterior distributions and making Bayesian inferences based on them. Functions are provided for doing quadrature and marginal Laplace approximations, and summary methods are provided for making inferences based on the results. See Stringer (2021). "Implementing Adaptive Quadrature for Bayesian Inference: the aghq Package" <arXiv:2101.04468>.
Maintained by Alex Stringer. Last updated 1 years ago.
14.4 match 5 stars 5.67 score 62 scripts 1 dependentslme4
lme4:Linear Mixed-Effects Models using 'Eigen' and S4
Fit linear and generalized linear mixed-effects models. The models and their components are represented using S4 classes and methods. The core computational algorithms are implemented using the 'Eigen' C++ library for numerical linear algebra and 'RcppEigen' "glue".
Maintained by Ben Bolker. Last updated 3 days ago.
3.5 match 647 stars 20.69 score 35k scripts 1.5k dependentsk3jph
cmna:Computational Methods for Numerical Analysis
Provides the source and examples for James P. Howard, II, "Computational Methods for Numerical Analysis with R," <https://jameshoward.us/cmna/>, a book on numerical methods in R.
Maintained by James Howard. Last updated 4 years ago.
bisectiondifferential-equationsheat-equationinterpolationleast-squaresmatrix-factorizationmonte-carlonewtonnumerical-analysisoptimizationpartial-differential-equationsquadratureroot-findingsecantsplinestestthattraveling-salespersonwave-equation
10.0 match 16 stars 5.65 score 62 scripts 3 dependentsdrizopoulos
GLMMadaptive:Generalized Linear Mixed Models using Adaptive Gaussian Quadrature
Fits generalized linear mixed models for a single grouping factor under maximum likelihood approximating the integrals over the random effects with an adaptive Gaussian quadrature rule; Jose C. Pinheiro and Douglas M. Bates (1995) <doi:10.1080/10618600.1995.10474663>.
Maintained by Dimitris Rizopoulos. Last updated 6 days ago.
generalized-linear-mixed-modelsmixed-effects-modelsmixed-models
5.0 match 61 stars 10.37 score 212 scripts 5 dependentsdhetting
GregoryQuadrature:Gregory Weights for Function Integration
Computes Gregory weights for a given number nodes and function order. Anthony Ralston and Philip Rabinowitz (2001) <ISBN:9780486414546>
Maintained by Dylan Hettinger. Last updated 11 months ago.
numerical-integrationquadrature
11.5 match 4.00 scoregksmyth
statmod:Statistical Modeling
A collection of algorithms and functions to aid statistical modeling. Includes limiting dilution analysis (aka ELDA), growth curve comparisons, mixed linear models, heteroscedastic regression, inverse-Gaussian probability calculations, Gauss quadrature and a secure convergence algorithm for nonlinear models. Also includes advanced generalized linear model functions including Tweedie and Digamma distributional families, secure convergence and exact distributional calculations for unit deviances.
Maintained by Gordon Smyth. Last updated 2 years ago.
4.6 match 1 stars 9.62 score 2.2k scripts 849 dependentsdrizopoulos
ltm:Latent Trait Models under IRT
Analysis of multivariate dichotomous and polytomous data using latent trait models under the Item Response Theory approach. It includes the Rasch, the Two-Parameter Logistic, the Birnbaum's Three-Parameter, the Graded Response, and the Generalized Partial Credit Models.
Maintained by Dimitris Rizopoulos. Last updated 3 years ago.
3.8 match 30 stars 9.59 score 1.0k scripts 27 dependentslaplacesdemonr
LaplacesDemon:Complete Environment for Bayesian Inference
Provides a complete environment for Bayesian inference using a variety of different samplers (see ?LaplacesDemon for an overview).
Maintained by Henrik Singmann. Last updated 12 months ago.
2.3 match 93 stars 13.45 score 1.8k scripts 60 dependentsirtools
irtoys:A Collection of Functions Related to Item Response Theory (IRT)
A collection of functions useful in learning and practicing IRT, which can be combined into larger programs. Provides basic CTT analysis, a simple common interface to the estimation of item parameters in IRT models for binary responses with three different programs (ICL, BILOG-MG, and ltm), ability estimation (MLE, BME, EAP, WLE, plausible values), item and person fit statistics, scaling methods (MM, MS, Stocking-Lord, and the complete Hebaera method), and a rich array of parametric and non-parametric (kernel) plots. Estimates and plots Haberman's interaction model when all items are dichotomously scored.
Maintained by Ivailo Partchev. Last updated 3 years ago.
4.1 match 3 stars 5.39 score 55 scripts 5 dependentsjamesramsay5
fda:Functional Data Analysis
These functions were developed to support functional data analysis as described in Ramsay, J. O. and Silverman, B. W. (2005) Functional Data Analysis. New York: Springer and in Ramsay, J. O., Hooker, Giles, and Graves, Spencer (2009). Functional Data Analysis with R and Matlab (Springer). The package includes data sets and script files working many examples including all but one of the 76 figures in this latter book. Matlab versions are available by ftp from <https://www.psych.mcgill.ca/misc/fda/downloads/FDAfuns/>.
Maintained by James Ramsay. Last updated 4 months ago.
1.8 match 3 stars 12.29 score 2.0k scripts 143 dependentsrefunders
refund:Regression with Functional Data
Methods for regression for functional data, including function-on-scalar, scalar-on-function, and function-on-function regression. Some of the functions are applicable to image data.
Maintained by Julia Wrobel. Last updated 6 months ago.
2.0 match 41 stars 10.25 score 472 scripts 16 dependentsmarco-geraci
lqmm:Linear Quantile Mixed Models
Functions to fit quantile regression models for hierarchical data (2-level nested designs) as described in Geraci and Bottai (2014, Statistics and Computing) <doi:10.1007/s11222-013-9381-9>. A vignette is given in Geraci (2014, Journal of Statistical Software) <doi:10.18637/jss.v057.i13> and included in the package documents. The packages also provides functions to fit quantile models for independent data and for count responses.
Maintained by Marco Geraci. Last updated 3 years ago.
4.5 match 4.38 score 75 scripts 5 dependentsspatstat
spatstat.random:Random Generation Functionality for the 'spatstat' Family
Functionality for random generation of spatial data in the 'spatstat' family of packages. Generates random spatial patterns of points according to many simple rules (complete spatial randomness, Poisson, binomial, random grid, systematic, cell), randomised alteration of patterns (thinning, random shift, jittering), simulated realisations of random point processes including simple sequential inhibition, Matern inhibition models, Neyman-Scott cluster processes (using direct, Brix-Kendall, or hybrid algorithms), log-Gaussian Cox processes, product shot noise cluster processes and Gibbs point processes (using Metropolis-Hastings birth-death-shift algorithm, alternating Gibbs sampler, or coupling-from-the-past perfect simulation). Also generates random spatial patterns of line segments, random tessellations, and random images (random noise, random mosaics). Excludes random generation on a linear network, which is covered by the separate package 'spatstat.linnet'.
Maintained by Adrian Baddeley. Last updated 2 days ago.
point-processesrandom-generationsimulationspatial-samplingspatial-simulationcpp
1.7 match 5 stars 10.82 score 84 scripts 175 dependentsspatstat
spatstat.linnet:Linear Networks Functionality of the 'spatstat' Family
Defines types of spatial data on a linear network and provides functionality for geometrical operations, data analysis and modelling of data on a linear network, in the 'spatstat' family of packages. Contains definitions and support for linear networks, including creation of networks, geometrical measurements, topological connectivity, geometrical operations such as inserting and deleting vertices, intersecting a network with another object, and interactive editing of networks. Data types defined on a network include point patterns, pixel images, functions, and tessellations. Exploratory methods include kernel estimation of intensity on a network, K-functions and pair correlation functions on a network, simulation envelopes, nearest neighbour distance and empty space distance, relative risk estimation with cross-validated bandwidth selection. Formal hypothesis tests of random pattern (chi-squared, Kolmogorov-Smirnov, Monte Carlo, Diggle-Cressie-Loosmore-Ford, Dao-Genton, two-stage Monte Carlo) and tests for covariate effects (Cox-Berman-Waller-Lawson, Kolmogorov-Smirnov, ANOVA) are also supported. Parametric models can be fitted to point pattern data using the function lppm() similar to glm(). Only Poisson models are implemented so far. Models may involve dependence on covariates and dependence on marks. Models are fitted by maximum likelihood. Fitted point process models can be simulated, automatically. Formal hypothesis tests of a fitted model are supported (likelihood ratio test, analysis of deviance, Monte Carlo tests) along with basic tools for model selection (stepwise(), AIC()) and variable selection (sdr). Tools for validating the fitted model include simulation envelopes, residuals, residual plots and Q-Q plots, leverage and influence diagnostics, partial residuals, and added variable plots. Random point patterns on a network can be generated using a variety of models.
Maintained by Adrian Baddeley. Last updated 2 months ago.
density-estimationheat-equationkernel-density-estimationnetwork-analysispoint-processesspatial-data-analysisstatistical-analysisstatistical-inferencestatistical-models
1.9 match 6 stars 9.64 score 35 scripts 43 dependentsegarpor
DirStats:Nonparametric Methods for Directional Data
Nonparametric kernel density estimation, bandwidth selection, and other utilities for analyzing directional data. Implements the estimator in Bai, Rao and Zhao (1987) <doi:10.1016/0047-259X(88)90113-3>, the cross-validation bandwidth selectors in Hall, Watson and Cabrera (1987) <doi:10.1093/biomet/74.4.751> and the plug-in bandwidth selectors in García-Portugués (2013) <doi:10.1214/13-ejs821>.
Maintained by Eduardo García-Portugués. Last updated 2 years ago.
directional-statisticsnonparametric-statisticsstatisticsfortran
4.0 match 12 stars 4.26 score 7 scripts 1 dependentsbjw34032
waveslim:Basic Wavelet Routines for One-, Two-, and Three-Dimensional Signal Processing
Basic wavelet routines for time series (1D), image (2D) and array (3D) analysis. The code provided here is based on wavelet methodology developed in Percival and Walden (2000); Gencay, Selcuk and Whitcher (2001); the dual-tree complex wavelet transform (DTCWT) from Kingsbury (1999, 2001) as implemented by Selesnick; and Hilbert wavelet pairs (Selesnick 2001, 2002). All figures in chapters 4-7 of GSW (2001) are reproducible using this package and R code available at the book website(s) below.
Maintained by Brandon Whitcher. Last updated 10 months ago.
2.0 match 3 stars 7.88 score 108 scripts 23 dependentsjmhewitt
bisque:Approximate Bayesian Inference via Sparse Grid Quadrature Evaluation (BISQuE) for Hierarchical Models
Implementation of the 'bisque' strategy for approximate Bayesian posterior inference. See Hewitt and Hoeting (2019) <arXiv:1904.07270> for complete details. 'bisque' combines conditioning with sparse grid quadrature rules to approximate marginal posterior quantities of hierarchical Bayesian models. The resulting approximations are computationally efficient for many hierarchical Bayesian models. The 'bisque' package allows approximate posterior inference for custom models; users only need to specify the conditional densities required for the approximation.
Maintained by Joshua Hewitt. Last updated 5 years ago.
4.9 match 1 stars 3.18 score 10 scriptsspatstat
spatstat.model:Parametric Statistical Modelling and Inference for the 'spatstat' Family
Functionality for parametric statistical modelling and inference for spatial data, mainly spatial point patterns, in the 'spatstat' family of packages. (Excludes analysis of spatial data on a linear network, which is covered by the separate package 'spatstat.linnet'.) Supports parametric modelling, formal statistical inference, and model validation. Parametric models include Poisson point processes, Cox point processes, Neyman-Scott cluster processes, Gibbs point processes and determinantal point processes. Models can be fitted to data using maximum likelihood, maximum pseudolikelihood, maximum composite likelihood and the method of minimum contrast. Fitted models can be simulated and predicted. Formal inference includes hypothesis tests (quadrat counting tests, Cressie-Read tests, Clark-Evans test, Berman test, Diggle-Cressie-Loosmore-Ford test, scan test, studentised permutation test, segregation test, ANOVA tests of fitted models, adjusted composite likelihood ratio test, envelope tests, Dao-Genton test, balanced independent two-stage test), confidence intervals for parameters, and prediction intervals for point counts. Model validation techniques include leverage, influence, partial residuals, added variable plots, diagnostic plots, pseudoscore residual plots, model compensators and Q-Q plots.
Maintained by Adrian Baddeley. Last updated 8 days ago.
analysis-of-variancecluster-processconfidence-intervalscox-processdeterminantal-point-processesgibbs-processinfluenceleveragemodel-diagnosticsneyman-scottparameter-estimationpoisson-processspatial-analysisspatial-modellingspatial-point-processesstatistical-inference
1.7 match 5 stars 9.09 score 6 scripts 46 dependentsswihart
rmutil:Utilities for Nonlinear Regression and Repeated Measurements Models
A toolkit of functions for nonlinear regression and repeated measurements not to be used by itself but called by other Lindsey packages such as 'gnlm', 'stable', 'growth', 'repeated', and 'event' (available at <https://www.commanster.eu/rcode.html>).
Maintained by Bruce Swihart. Last updated 2 years ago.
1.8 match 1 stars 8.35 score 358 scripts 70 dependentsmlr-org
mlr3mbo:Flexible Bayesian Optimization
A modern and flexible approach to Bayesian Optimization / Model Based Optimization building on the 'bbotk' package. 'mlr3mbo' is a toolbox providing both ready-to-use optimization algorithms as well as their fundamental building blocks allowing for straightforward implementation of custom algorithms. Single- and multi-objective optimization is supported as well as mixed continuous, categorical and conditional search spaces. Moreover, using 'mlr3mbo' for hyperparameter optimization of machine learning models within the 'mlr3' ecosystem is straightforward via 'mlr3tuning'. Examples of ready-to-use optimization algorithms include Efficient Global Optimization by Jones et al. (1998) <doi:10.1023/A:1008306431147>, ParEGO by Knowles (2006) <doi:10.1109/TEVC.2005.851274> and SMS-EGO by Ponweiser et al. (2008) <doi:10.1007/978-3-540-87700-4_78>.
Maintained by Lennart Schneider. Last updated 13 days ago.
automlbayesian-optimizationbbotkblack-box-optimizationgaussian-processhpohyperparameterhyperparameter-optimizationhyperparameter-tuningmachine-learningmlr3model-based-optimizationoptimizationoptimizerrandom-foresttuning
1.7 match 25 stars 8.57 score 120 scripts 3 dependentsr-forge
distrEx:Extensions of Package 'distr'
Extends package 'distr' by functionals, distances, and conditional distributions.
Maintained by Matthias Kohl. Last updated 2 months ago.
2.0 match 6.68 score 107 scripts 17 dependentsknoths
spc:Statistical Process Control -- Calculation of ARL and Other Control Chart Performance Measures
Evaluation of control charts by means of the zero-state, steady-state ARL (Average Run Length) and RL quantiles. Setting up control charts for given in-control ARL. The control charts under consideration are one- and two-sided EWMA, CUSUM, and Shiryaev-Roberts schemes for monitoring the mean or variance of normally distributed independent data. ARL calculation of the same set of schemes under drift (in the mean) are added. Eventually, all ARL measures for the multivariate EWMA (MEWMA) are provided.
Maintained by Sven Knoth. Last updated 7 months ago.
3.9 match 5 stars 3.30 score 66 scripts 1 dependentsegarpor
sphunif:Uniformity Tests on the Circle, Sphere, and Hypersphere
Implementation of uniformity tests on the circle and (hyper)sphere. The main function of the package is unif_test(), which conveniently collects more than 35 tests for assessing uniformity on S^{p-1} = {x in R^p : ||x|| = 1}, p >= 2. The test statistics are implemented in the unif_stat() function, which allows computing several statistics for different samples within a single call, thus facilitating Monte Carlo experiments. Furthermore, the unif_stat_MC() function allows parallelizing them in a simple way. The asymptotic null distributions of the statistics are available through the function unif_stat_distr(). The core of 'sphunif' is coded in C++ by relying on the 'Rcpp' package. The package also provides several novel datasets and gives the replicability for the data applications/simulations in García-Portugués et al. (2021) <doi:10.1007/978-3-030-69944-4_12>, García-Portugués et al. (2023) <doi:10.3150/21-BEJ1454>, García-Portugués et al. (2024) <doi:10.48550/arXiv.2108.09874>, and Fernández-de-Marcos and García-Portugués (2024) <doi:10.48550/arXiv.2405.13531>.
Maintained by Eduardo García-Portugués. Last updated 10 months ago.
circular-statisticsdirectional-statisticsuniformityuniformity-testsopenblascpp
2.0 match 8 stars 6.11 score 18 scripts 2 dependentscran
gss:General Smoothing Splines
A comprehensive package for structural multivariate function estimation using smoothing splines.
Maintained by Chong Gu. Last updated 5 months ago.
1.9 match 3 stars 6.40 score 137 dependentstraitecoevo
plant:A Package for Modelling Forest Trait Ecology and Evolution
Solves trait, size and patch structured model from (Falster et al. 2016) using either method of characteristics or as stochastic, finite-sized population.
Maintained by Daniel Falster. Last updated 8 days ago.
c-plus-plusdemographydynamicecologyevolutionforestsplant-physiologyscience-researchsimulationtraitcpp
2.0 match 53 stars 5.87 scorejaimemosg
EstimationTools:Maximum Likelihood Estimation for Probability Functions from Data Sets
Total Time on Test plot and routines for parameter estimation of any lifetime distribution implemented in R via maximum likelihood (ML) given a data set. It is implemented thinking on parametric survival analysis, but it feasible to use in parameter estimation of probability density or mass functions in any field. The main routines 'maxlogL' and 'maxlogLreg' are wrapper functions specifically developed for ML estimation. There are included optimization procedures such as 'nlminb' and 'optim' from base package, and 'DEoptim' Mullen (2011) <doi:10.18637/jss.v040.i06>. Standard errors are estimated with 'numDeriv' Gilbert (2011) <https://CRAN.R-project.org/package=numDeriv> or the option 'Hessian = TRUE' of 'optim' function.
Maintained by Jaime Mosquera. Last updated 1 years ago.
distance-samplingmaximum-likelihood-estimationttt-plot
1.9 match 4 stars 6.07 score 97 scripts 1 dependentsiagogv3
GramQuad:Gram Quadrature
Numerical integration with Gram polynomials (based on <arXiv:2106.14875> [math.NA] 28 Jun 2021, by Irfan Muhammad [School of Computer Science, University of Birmingham, UK]).
Maintained by Iago Giné-Vázquez. Last updated 1 years ago.
3.8 match 2.70 scoreealdrich
wavelets:Functions for Computing Wavelet Filters, Wavelet Transforms and Multiresolution Analyses
Contains functions for computing and plotting discrete wavelet transforms (DWT) and maximal overlap discrete wavelet transforms (MODWT), as well as their inverses. Additionally, it contains functionality for computing and plotting wavelet transform filters that are used in the above decompositions as well as multiresolution analyses.
Maintained by Eric Aldrich. Last updated 5 years ago.
2.0 match 4 stars 4.90 score 170 scripts 19 dependentsjmzobitz
neonSoilFlux:Compute Soil Carbon Fluxes for the National Ecological Observatory Network Sites
Acquires and synthesizes soil carbon fluxes at sites located in the National Ecological Observatory Network (NEON). Provides flux estimates and associated uncertainty as well as key environmental measurements (soil water, temperature, CO2 concentration) that are used to compute soil fluxes.
Maintained by John Zobitz. Last updated 10 months ago.
1.8 match 6 stars 5.43 score 2 scriptsashesitr
reservr:Fit Distributions and Neural Networks to Censored and Truncated Data
Define distribution families and fit them to interval-censored and interval-truncated data, where the truncation bounds may depend on the individual observation. The defined distributions feature density, probability, sampling and fitting methods as well as efficient implementations of the log-density log f(x) and log-probability log P(x0 <= X <= x1) for use in 'TensorFlow' neural networks via the 'tensorflow' package. Allows training parametric neural networks on interval-censored and interval-truncated data with flexible parameterization. Applications include Claims Development in Non-Life Insurance, e.g. modelling reporting delay distributions from incomplete data, see Bücher, Rosenstock (2022) <doi:10.1007/s13385-022-00314-4>.
Maintained by Alexander Rosenstock. Last updated 9 months ago.
1.8 match 5 stars 5.35 score 9 scriptsboennecd
SimSurvNMarker:Simulate Survival Time and Markers
Provides functions to simulate from joint survival and marker models. The user can specific all basis functions of time, random or deterministic covariates, random or deterministic left-truncation and right-censoring times, and model parameters.
Maintained by Benjamin Christoffersen. Last updated 2 years ago.
simulationsurvival-analysisopenblascppopenmp
1.8 match 3 stars 5.29 score 43 scripts 1 dependentsgilberto-sassi
geoFourierFDA:Ordinary Functional Kriging Using Fourier Smoothing and Gaussian Quadrature
Implementation of the ordinary functional kriging method proposed by Giraldo (2011) <doi:10.1007/s10651-010-0143-y>. This implements an alternative method to estimate the trace-variogram using Fourier Smoothing and Gaussian Quadrature.
Maintained by Gilberto Sassi. Last updated 4 years ago.
3.3 match 2.70 score 3 scriptsmikejareds
hermiter:Efficient Sequential and Batch Estimation of Univariate and Bivariate Probability Density Functions and Cumulative Distribution Functions along with Quantiles (Univariate) and Nonparametric Correlation (Bivariate)
Facilitates estimation of full univariate and bivariate probability density functions and cumulative distribution functions along with full quantile functions (univariate) and nonparametric correlation (bivariate) using Hermite series based estimators. These estimators are particularly useful in the sequential setting (both stationary and non-stationary) and one-pass batch estimation setting for large data sets. Based on: Stephanou, Michael, Varughese, Melvin and Macdonald, Iain. "Sequential quantiles via Hermite series density estimation." Electronic Journal of Statistics 11.1 (2017): 570-607 <doi:10.1214/17-EJS1245>, Stephanou, Michael and Varughese, Melvin. "On the properties of Hermite series based distribution function estimators." Metrika (2020) <doi:10.1007/s00184-020-00785-z> and Stephanou, Michael and Varughese, Melvin. "Sequential estimation of Spearman rank correlation using Hermite series estimators." Journal of Multivariate Analysis (2021) <doi:10.1016/j.jmva.2021.104783>.
Maintained by Michael Stephanou. Last updated 7 months ago.
cumulative-distribution-functionkendall-correlation-coefficientonline-algorithmsprobability-density-functionquantilespearman-correlation-coefficientstatisticsstreaming-algorithmsstreaming-datacpp
1.6 match 15 stars 5.58 score 17 scriptsamerican-institutes-for-research
WeMix:Weighted Mixed-Effects Models Using Multilevel Pseudo Maximum Likelihood Estimation
Run mixed-effects models that include weights at every level. The WeMix package fits a weighted mixed model, also known as a multilevel, mixed, or hierarchical linear model (HLM). The weights could be inverse selection probabilities, such as those developed for an education survey where schools are sampled probabilistically, and then students inside of those schools are sampled probabilistically. Although mixed-effects models are already available in R, WeMix is unique in implementing methods for mixed models using weights at multiple levels. Both linear and logit models are supported. Models may have up to three levels. Random effects are estimated using the PIRLS algorithm from 'lme4pureR' (Walker and Bates (2013) <https://github.com/lme4/lme4pureR>).
Maintained by Paul Bailey. Last updated 5 months ago.
1.3 match 10 stars 6.31 score 33 scripts 2 dependentsalex-haixuw
pCODE:Estimation of an Ordinary Differential Equation Model by Parameter Cascade Method
An implementation of the parameter cascade method Ramsay, J. O., Hooker,G., Campbell, D., and Cao, J. (2007) <doi:10.1111/j.1467-9868.2007.00610.x> for estimating ordinary differential equation models with missing or complete observations. It combines smoothing method and profile estimation to estimate any non-linear dynamic system. The package also offers variance estimates for parameters of interest based on either bootstrap or Delta method.
Maintained by Haixu Wang. Last updated 3 years ago.
1.7 match 3 stars 4.48 score 6 scriptsphilchalmers
mirt:Multidimensional Item Response Theory
Analysis of discrete response data using unidimensional and multidimensional item analysis models under the Item Response Theory paradigm (Chalmers (2012) <doi:10.18637/jss.v048.i06>). Exploratory and confirmatory item factor analysis models are estimated with quadrature (EM) or stochastic (MHRM) methods. Confirmatory bi-factor and two-tier models are available for modeling item testlets using dimension reduction EM algorithms, while multiple group analyses and mixed effects designs are included for detecting differential item, bundle, and test functioning, and for modeling item and person covariates. Finally, latent class models such as the DINA, DINO, multidimensional latent class, mixture IRT models, and zero-inflated response models are supported, as well as a wide family of probabilistic unfolding models.
Maintained by Phil Chalmers. Last updated 11 days ago.
0.5 match 210 stars 14.98 score 2.5k scripts 40 dependentsklausherrmann
multIntTestFunc:Provides Test Functions for Multivariate Integration
Provides implementations of functions that can be used to test multivariate integration routines. The package covers six different integration domains (unit hypercube, unit ball, unit sphere, standard simplex, non-negative real numbers and R^n). For each domain several functions with different properties (smooth, non-differentiable, ...) are available. The functions are available in all dimensions n >= 1. For each function the exact value of the integral is known and implemented to allow testing the accuracy of multivariate integration routines. Details on the available test functions can be found at on the development website.
Maintained by Klaus Herrmann. Last updated 6 months ago.
1.7 match 4.30 score 1 scriptsjeinbeck-code
npmlreg:Nonparametric Maximum Likelihood Estimation for Random Effect Models
Nonparametric maximum likelihood estimation or Gaussian quadrature for overdispersed generalized linear models and variance component models.
Maintained by Jochen Einbeck. Last updated 7 years ago.
2.2 match 3.26 score 30 scripts 1 dependentsegarpor
sdetorus:Statistical Tools for Toroidal Diffusions
Implementation of statistical methods for the estimation of toroidal diffusions. Several diffusive models are provided, most of them belonging to the Langevin family of diffusions on the torus. Specifically, the wrapped normal and von Mises processes are included, which can be seen as toroidal analogues of the Ornstein-Uhlenbeck diffusion. A collection of methods for approximate maximum likelihood estimation, organized in four blocks, is given: (i) based on the exact transition probability density, obtained as the numerical solution to the Fokker-Plank equation; (ii) based on wrapped pseudo-likelihoods; (iii) based on specific analytic approximations by wrapped processes; (iv) based on maximum likelihood of the stationary densities. The package allows the replicability of the results in García-Portugués et al. (2019) <doi:10.1007/s11222-017-9790-2>.
Maintained by Eduardo García-Portugués. Last updated 1 years ago.
circular-statisticsinferencemaximum-likelihoodreproducible-researchsdestatisticstoroidal-dataopenblascpp
1.8 match 5 stars 3.88 score 9 scripts 1 dependentsrunehaubo
ordinal:Regression Models for Ordinal Data
Implementation of cumulative link (mixed) models also known as ordered regression models, proportional odds models, proportional hazards models for grouped survival times and ordered logit/probit/... models. Estimation is via maximum likelihood and mixed models are fitted with the Laplace approximation and adaptive Gauss-Hermite quadrature. Multiple random effect terms are allowed and they may be nested, crossed or partially nested/crossed. Restrictions of symmetry and equidistance can be imposed on the thresholds (cut-points/intercepts). Standard model methods are available (summary, anova, drop-methods, step, confint, predict etc.) in addition to profile methods and slice methods for visualizing the likelihood function and checking convergence.
Maintained by Rune Haubo Bojesen Christensen. Last updated 3 months ago.
0.5 match 38 stars 12.41 score 1.3k scripts 178 dependentsplambertuliege
cubicBsplines:Computation of a Cubic B-Spline Basis and Its Derivatives
Computation of a cubic B-spline basis for arbitrary knots. It also provides the 1st and 2nd derivatives, as well as the integral of the basis elements. It is used by the author to fit penalized B-spline models, see e.g. Jullion, A. and Lambert, P. (2006) <doi:10.1016/j.csda.2006.09.027>, Lambert, P. and Eilers, P.H.C. (2009) <doi:10.1016/j.csda.2008.11.022> and, more recently, Lambert, P. (2021) <doi:10.1016/j.csda.2021.107250>. It is inspired by the algorithm developed by de Boor, C. (1977) <doi:10.1137/0714026>.
Maintained by Philippe Lambert. Last updated 2 years ago.
1.7 match 1 stars 3.65 score 2 scripts 3 dependentspvkabaila
custom.gauss.quad:Custom Made Gauss Quadrature Nodes and Weights
Use the high-precision arithmetic provided by the R package 'Rmpfr' to compute a custom-made Gauss quadrature nodes and weights, with up to 33 nodes, using a moment-based method via moment determinants. Paul Kabaila (2022) <arXiv:2211.04729>.
Maintained by Paul Kabaila. Last updated 2 years ago.
5.2 match 1.00 scorejasonwilson2024
PCS:Calculate the Probability of Correct Selection (PCS)
Given k populations (can be in thousands), what is the probability that a given subset of size t contains the true top t populations? This package finds this probability and offers three tuning parameters (G, d, L) to relax the definition.
Maintained by Jason Wilson. Last updated 3 years ago.
1.9 match 2.00 score 1 scriptsiwrenner
ppmlasso:Point Process Models with LASSO-Type Penalties
Toolkit for fitting point process models with sequences of LASSO penalties ("regularisation paths"), as described in Renner, I.W. and Warton, D.I. (2013) <doi:10.1111/j.1541-0420.2012.01824.x>. Regularisation paths of Poisson point process models or area-interaction models can be fitted with LASSO, adaptive LASSO or elastic net penalties. A number of criteria are available to judge the bias-variance tradeoff.
Maintained by Ian Renner. Last updated 1 years ago.
1.7 match 2 stars 1.45 score 14 scriptsokamumu
deformula:Integration of One-Dimensional Functions with Double Exponential Formulas
Numerical quadrature of functions of one variable over a finite or infinite interval with double exponential formulas.
Maintained by Hiroyuki Okamura. Last updated 3 years ago.
0.5 match 3.18 score 6 scripts 1 dependentscran
BayesGP:Efficient Implementation of Gaussian Process in Bayesian Hierarchical Models
Implements Bayesian hierarchical models with flexible Gaussian process priors, focusing on Extended Latent Gaussian Models and incorporating various Gaussian process priors for Bayesian smoothing. Computations leverage finite element approximations and adaptive quadrature for efficient inference. Methods are detailed in Zhang, Stringer, Brown, and Stafford (2023) <doi:10.1177/09622802221134172>; Zhang, Stringer, Brown, and Stafford (2024) <doi:10.1080/10618600.2023.2289532>; Zhang, Brown, and Stafford (2023) <doi:10.48550/arXiv.2305.09914>; and Stringer, Brown, and Stafford (2021) <doi:10.1111/biom.13329>.
Maintained by Ziang Zhang. Last updated 4 months ago.
0.5 match 3.18 scorem-signo
ptmixed:Poisson-Tweedie Generalized Linear Mixed Model
Fits the Poisson-Tweedie generalized linear mixed model described in Signorelli et al. (2021, <doi:10.1177/1471082X20936017>). Likelihood approximation based on adaptive Gauss Hermite quadrature rule.
Maintained by Mirko Signorelli. Last updated 3 years ago.
0.5 match 2.15 score 14 scriptscran
dixonTest:Dixon's Ratio Test for Outlier Detection
For outlier detection in small and normally distributed samples the ratio test of Dixon (Q-test) can be used. Density, distribution function, quantile function and random generation for Dixon's ratio statistics are provided as wrapper functions. The core applies McBane's Fortran functions <doi:10.18637/jss.v016.i03> that use Gaussian quadrature for a numerical solution.
Maintained by Thorsten Pohlert. Last updated 3 years ago.
0.5 match 1.48 score 3 scripts 1 dependents