r-mdir.logrank
|
public |
Implemented are the one-sided and two-sided multiple-direction logrank test for two-sample right censored data. In addition to the statistics p-values are calculated: 1. For the one-sided testing problem one p-value based on a wild bootstrap approach is determined. 2. In the two-sided case one p-value based on a chi-squared approximation and a second p-values based on a permutation approach are calculated. Ditzhaus, M. and Friedrich, S. (2018) <arXiv:1807.05504>. Ditzhaus, M. and Pauly, M. (2018) <arXiv:1808.05627>.
|
2023-06-16 |
r-mdatools
|
public |
Package implements projection based methods for preprocessing, exploring and analysis of multivariate data used in chemometrics.
|
2023-06-16 |
r-mcmcplots
|
public |
Functions for convenient plotting and viewing of MCMC output.
|
2023-06-16 |
r-mci
|
public |
Market area models are used to analyze and predict store choices and market areas concerning retail and service locations. This package implements two market area models (Huff Model, Multiplicative Competitive Interaction Model) into R, while the emphases lie on 1.) fitting these models based on empirical data via OLS regression and nonlinear techniques and 2.) data preparation and processing (esp. interaction matrices and data preparation for the MCI Model).
|
2023-06-16 |
r-mazegen
|
public |
A maze generator that creates the Elithorn Maze (HTML file) and the functions to calculate the associated maze parameters (i.e. Difficulty and Ability).
|
2023-06-16 |
r-matrixstructest
|
public |
Tests for block-diagonal structure in symmetric matrices (e.g. correlation matrices) under the null hypothesis of exchangeable off-diagonal elements. As described in Segal et al. (2019), these tests can be useful for construct validation either by themselves or as a complement to confirmatory factor analysis. Monte Carlo methods are used to approximate the permutation p-value with Hubert's Gamma (Hubert, 1976) and a t-statistic. This package also implements the chi-squared statistic described by Steiger (1980). Please see Segal, et al. (2019) <doi:10.1007/s11336-018-9647-4> for more information.
|
2023-06-16 |
r-mad
|
public |
A collection of functions for conducting a meta-analysis with mean differences data. It uses recommended procedures as described in The Handbook of Research Synthesis and Meta-Analysis (Cooper, Hedges, & Valentine, 2009).
|
2023-06-16 |
r-lsmontecarlo
|
public |
The package compiles functions for calculating prices of American put options with Least Squares Monte Carlo method. The option types are plain vanilla American put, Asian American put, and Quanto American put. The pricing algorithms include variance reduction techniques such as Antithetic Variates and Control Variates. Additional functions are given to derive "price surfaces" at different volatilities and strikes, create 3-D plots, quickly generate Geometric Brownian motion, and calculate prices of European options with Black & Scholes analytical solution.
|
2023-06-16 |
r-lps
|
public |
An implementation of the Linear Predictor Score approach, as initiated by Radmacher et al. (J Comput Biol 2001) and enhanced by Wright et al. (PNAS 2003) for gene expression signatures. Several tools for unsupervised clustering of gene expression data are also provided.
|
2023-06-16 |
r-lincal
|
public |
Estimate and confidence/credible intervals for an unknown regressor x0 given an observed y0.
|
2023-06-16 |
r-nmfn
|
public |
Non-negative Matrix Factorization
|
2023-06-16 |
r-nlsr
|
public |
Provides tools for working with nonlinear least squares problems. It is intended to eventually supersede the 'nls()' function in the R distribution. For example, 'nls()' specifically does NOT deal with small or zero residual problems as its Gauss-Newton method frequently stops with 'singular gradient' messages. 'nlsr' is based on the now-deprecated package 'nlmrt', and has refactored functions and R-language symbolic derivative features.
|
2023-06-16 |
r-nlcoptim
|
public |
Optimization for nonlinear objective and constraint functions. Linear or nonlinear equality and inequality constraints are allowed. It accepts the input parameters as a constrained matrix.
|
2023-06-16 |
r-nestfs
|
public |
Implementation of forward selection based on cross-validated linear and logistic regression.
|
2023-06-16 |
r-naptime
|
public |
Provides a near drop-in replacement for base::Sys.sleep() that allows more types of input to produce delays in the execution of code and can silence/prevent typical sources of error.
|
2023-06-16 |
r-naivebayes
|
public |
In this implementation of the Naive Bayes classifier following class conditional distributions are available: Bernoulli, Categorical, Gaussian, Poisson and non-parametric representation of the class conditional density estimated via Kernel Density Estimation.
|
2023-06-16 |
r-nada
|
public |
Contains methods described by Dennis Helsel in his book "Nondetects And Data Analysis: Statistics for Censored Environmental Data".
|
2023-06-16 |
r-myrrixjars
|
public |
External jars required for package 'Myrrix'. 'Myrrix' is a recommendation engine.
|
2023-06-16 |
r-mvbinary
|
public |
Modelling Multivariate Binary Data with Blocks of Specific One-Factor Distribution. Variables are grouped into independent blocks. Each variable is described by two continuous parameters (its marginal probability and its dependency strength with the other block variables), and one binary parameter (positive or negative dependency). Model selection consists in the estimation of the repartition of the variables into blocks. It is carried out by the maximization of the BIC criterion by a deterministic (faster) algorithm or by a stochastic (more time consuming but optimal) algorithm. Tool functions facilitate the model interpretation.
|
2023-06-16 |
r-multiplebubbles
|
public |
Provides the Augmented Dickey-Fuller test and its variations to check the existence of bubbles (explosive behavior) for time series, based on the article by Peter C. B. Phillips, Shuping Shi and Jun Yu (2015a) <doi:10.1111/iere.12131>. Some functions may take a while depending on the size of the data used, or the number of Monte Carlo replications applied.
|
2023-06-16 |
r-multifwf
|
public |
Read a table of fixed width formatted data of different types into a data.frame for each type.
|
2023-06-16 |
r-multica
|
public |
Implements a generalization of the Cochran-Armitage trend test to multinomial data. In addition to an overall test, multiple testing adjusted p-values for trend in individual outcomes and power calculation is available.
|
2023-06-16 |
r-multiapply
|
public |
The base apply function and its variants, as well as the related functions in the 'plyr' package, typically apply user-defined functions to a single argument (or a list of vectorized arguments in the case of mapply). The 'multiApply' package extends this paradigm with its only function, Apply, which efficiently applies functions taking one or a list of multiple unidimensional or multidimensional arrays (or combinations thereof) as input. The input arrays can have different numbers of dimensions as well as different dimension lengths, and the applied function can return one or a list of unidimensional or multidimensional arrays as output. This saves development time by preventing the R user from writing often error-prone and memory-inefficient loops dealing with multiple complex arrays. Also, a remarkable feature of Apply is the transparent use of multi-core through its parameter 'ncores'. In contrast to the base apply function, this package suggests the use of 'target dimensions' as opposite to the 'margins' for specifying the dimensions relevant to the function to be applied.
|
2023-06-16 |
r-multcompview
|
public |
Convert a logical vector or a vector of p-values or a correlation, difference, or distance matrix into a display identifying the pairs for which the differences were not significantly different. Designed for use in conjunction with the output of functions like TukeyHSD, dist{stats}, simint, simtest, csimint, csimtest{multcomp}, friedmanmc, kruskalmc{pgirmess}.
|
2023-06-16 |
r-mswm
|
public |
Estimation, inference and diagnostics for Univariate Autoregressive Markov Switching Models for Linear and Generalized Models. Distributions for the series include gaussian, Poisson, binomial and gamma cases. The EM algorithm is used for estimation (see Perlin (2012) <doi:10.2139/ssrn.1714016>).
|
2023-06-16 |
r-msgpackr
|
public |
This is the library that can serialize or unserialize MessagePack format data.
|
2023-06-16 |
r-msar
|
public |
Visualises multiple sequence alignments dynamically within the Shiny web application framework.
|
2023-06-16 |
r-monographar
|
public |
Contains functions intended to facilitate the production of plant taxonomic monographs. The package includes functions to convert tables into taxonomic descriptions, lists of collectors, examined specimens, and can generate a monograph skeleton. Additionally, wrapper functions to batch the production of phenology charts and distributional and diversity maps are also available.
|
2023-06-16 |
r-ml.msbd
|
public |
Inference of a multi-states birth-death model from a phylogeny, comprising a number of states N, birth and death rates for each state and on which edges each state appears. Inference is done using a hybrid approach: states are progressively added in a greedy approach. For a fixed number of states N the best model is selected via maximum likelihood. Reference: J. Barido-Sottani and T. Stadler (2017) <doi:10.1101/215491>.
|
2023-06-16 |
r-miscor
|
public |
Statistical test for the product-moment correlation coefficient based on H0: rho = rho0 including sample size computation, statistical test for comparing the product-moment correlation coefficient in independent ad dependent samples, sequential triangular test for the product-moment correlation coefficient, partial and semipartial correlation, simulation of bivariate normal and non-normal distribution with a specified correlation.
|
2023-06-16 |
r-migest
|
public |
Indirect methods for estimating bilateral migration flows in the presence of partial or missing data, including the estimation of bilateral migration flows from changes in bilateral migrant stock tables (e.g. Abel (2013) <doi:10.4054/DemRes.2013.28.18>).
|
2023-06-16 |
r-mgraster
|
public |
Convenience Functions for R Language Access to the v.1 API of the MG-RAST Metagenome Annotation Server, part of the US Department of Energy (DOE) Systems Biology Knowledge Base (KBase).
|
2023-06-16 |
r-methodcompare
|
public |
Implementation of the methodology from the paper titled "Effective plots to assess bias and precision in method comparison studies" published in Statistical Methods in Medical Research, P. Taffe (2016) <doi:10.1177/0962280216666667>.
|
2023-06-16 |
r-metablue
|
public |
The sample mean and standard deviation are two commonly used statistics in meta-analyses, but some trials use other summary statistics such as the median and quartiles to report the results. Therefore, researchers need to transform those information back to the sample mean and standard deviation. This package implemented sample mean estimators by Luo et al. (2016) <arXiv:1505.05687>, sample standard deviation estimators by Wan et al. (2014) <arXiv:1407.8038>, and the best linear unbiased estimators (BLUEs) of location and scale parameters by Yang et al. (2018, submitted) based on sample quantiles derived summaries in a meta-analysis.
|
2023-06-16 |
r-memss
|
public |
Data sets and sample analyses from Pinheiro and Bates, "Mixed-effects Models in S and S-PLUS" (Springer, 2000).
|
2023-06-16 |
r-mded
|
public |
Provides a function for measuring the difference between two independent or non-independent empirical distributions and returning a significance level of the difference.
|
2023-06-16 |
r-mconjoint
|
public |
The package aids in creating a Conjoint Analysis design with extra cards. Unlike traditional "holdout" cards these cards are used to create a set of "good" (balanced and low correlation) designs. Each of these designs is analyzed and the average calculated.
|
2023-06-16 |
r-maxnet
|
public |
Procedures to fit species distributions models from occurrence records and environmental variables, using 'glmnet' for model fitting. Model structure is the same as for the 'Maxent' Java package, version 3.4.0, with the same feature types and regularization options. See the 'Maxent' website <http://biodiversityinformatics.amnh.org/open_source/maxent> for more details.
|
2023-06-16 |
r-marl
|
public |
Functions provided allow data simulation; construction of weighted relative likelihood functions; clustering and principal component analysis based on weighted relative likelihood functions.
|
2023-06-16 |
r-marima
|
public |
Multivariate ARIMA and ARIMA-X estimation using Spliid's algorithm (marima()) and simulation (marima.sim()).
|
2023-06-16 |
r-manytests
|
public |
Performs the multiple testing procedures of Cox (2011) <doi:10.5170/CERN-2011-006> and Wong and Cox (2007) <doi:10.1080/02664760701240014>.
|
2023-06-16 |
r-mailr
|
public |
Interface to Apache Commons Email to send emails from R.
|
2023-06-16 |
r-lucid
|
public |
Print vectors (and data frames) of floating point numbers using a non-scientific format optimized for human readers. Vectors of numbers are rounded using significant digits, aligned at the decimal point, and all zeros trailing the decimal point are dropped. See: Wright (2016). Lucid: An R Package for Pretty-Printing Floating Point Numbers. In JSM Proceedings, Statistical Computing Section. Alexandria, VA: American Statistical Association. 2270-2279.
|
2023-06-16 |
r-lrth
|
public |
R code of a likelihood ratio test for genome-wide association under genetic heterogeneity.
|
2023-06-16 |
r-lmreg
|
public |
Data files and a few functions used in the book 'Linear Models and Regression with R: An Integrated Approach' by Debasis Sengupta and Sreenivas Rao Jammalamadaka (2019).
|
2023-06-16 |
r-lm.beta
|
public |
Adds standardized regression coefficients to objects created by lm. Also extends the S3 methods print, summary and coef with additional boolean argument standardized.
|
2023-06-16 |
r-librarysnapshot
|
public |
Generate a local library copy with relevant packages. All packages currently found within the search path - except base packages - will be copied to the directory provided and can be used later on with the .libPaths() function.
|
2023-06-16 |
r-lgtdl
|
public |
A very simple implementation of a class for longitudinal data.
|
2023-06-16 |
r-lettercase
|
public |
Utilities for formatting strings and character vectors to for capitalization, word break and white space. Supported formats are: snake_case, spine-case, camelCase, PascalCase, Title Case, UPPERCASE, lowercase, Sentence case or combinations thereof. 'lettercase' strives to provide a simple, consistent, intuitive and high performing interface.
|
2023-06-16 |
r-leiv
|
public |
Estimate the slope and intercept of a bivariate linear relationship by calculating a posterior density that is invariant to interchange and scaling of the coordinates.
|
2023-06-16 |