About Anaconda Help Download Anaconda

r_test / packages

Package Name Access Summary Updated
r-unifed public Probability functions and family for glm() of the unifed distribution (Quijano Xacur, 2018; <arXiv:1812.00251>). 2023-06-16
r-tracerer public 'BEAST2' (<http://www.beast2.org>) is a widely used Bayesian phylogenetic tool, that uses DNA/RNA/protein data and many model priors to create a posterior of jointly estimated phylogenies and parameters. 'Tracer' (<http://tree.bio.ed.ac.uk/software/tracer/>) is a GUI tool to parse and analyze the files generated by 'BEAST2'. This package provides a way to parse and analyze 'BEAST2' input files without active user input, but using R function calls instead. 2023-06-16
r-weco public Western Electric Company Rules (WECO) have been widely used for Shewhart control charts in order to increase the sensitivity of detecting assignable causes of process change. This package implements eight commonly used WECO rules and allow to apply the combination of these individual rules for detecting the deviation from a stable process. The package also provides a web-based graphical user interface to help users conduct the analysis. 2023-06-16
r-vita public Implements the novel testing approach by Janitza et al.(2015) <http://nbn-resolving.de/urn/resolver.pl?urn=nbn:de:bvb:19-epub-25587-4> for the permutation variable importance measure in a random forest and the PIMP-algorithm by Altmann et al.(2010) <doi:10.1093/bioinformatics/btq134>. Janitza et al.(2015) <http://nbn-resolving.de/urn/resolver.pl?urn=nbn:de:bvb:19-epub-25587-4> do not use the "standard" permutation variable importance but the cross-validated permutation variable importance for the novel test approach. The cross-validated permutation variable importance is not based on the out-of-bag observations but uses a similar strategy which is inspired by the cross-validation procedure. The novel test approach can be applied for classification trees as well as for regression trees. However, the use of the novel testing approach has not been tested for regression trees so far, so this routine is meant for the expert user only and its current state is rather experimental. 2023-06-16
r-tp.idm public Estimation of transition probabilities for the illness-death model. Both the Aalen-Johansen estimator for a Markov model and a novel non-Markovian estimator by de Una-Alvarez and Meira-Machado (2015) <doi:10.1111/biom.12288>, see also Balboa and de Una-Alvarez (2018) <doi:10.18637/jss.v083.i10>, are included. 2023-06-16
r-timereg public Programs for Martinussen and Scheike (2006), `Dynamic Regression Models for Survival Data', Springer Verlag. Plus more recent developments. Additive survival model, semiparametric proportional odds model, fast cumulative residuals, excess risk models and more. Flexible competing risks regression including GOF-tests. Two-stage frailty modelling. PLS for the additive risk model. Lasso in the 'ahaz' package. 2023-06-16
r-textreg public Function for sparse regression on raw text, regressing a labeling vector onto a feature space consisting of all possible phrases. 2023-06-16
r-webutils public Parses http request data in application/json, multipart/form-data, or application/x-www-form-urlencoded format. Includes example of hosting and parsing html form data in R using either 'httpuv' or 'Rhttpd'. 2023-06-16
r-webp public Lossless webp images are 26% smaller in size compared to PNG. Lossy webp images are 25-34% smaller in size compared to JPEG. This package reads and writes webp images into a 3 (rgb) or 4 (rgba) channel bitmap array using conventions from the 'jpeg' and 'png' packages. 2023-06-16
r-wdm public Provides efficient implementations of weighted dependence measures and related asymptotic tests for independence. Implemented measures are the Pearson correlation, Spearman's rho, Kendall's tau, Blomqvist's beta, and Hoeffding's D; see, e.g., Nelsen (2006) <doi:10.1007/0-387-28678-0> and Hollander et al. (2015, ISBN:9780470387375). 2023-06-16
r-wavelets public 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. 2023-06-16
r-vnm public Provide tools for finding multiple-objective optimal designs for estimating the shape of dose-response, the ED50 (the dose producing an effect midway between the expected responses at the extreme doses) and the MED (the minimum effective dose level) for the 2,3,4-parameter logistic models and for evaluating its efficiencies for the three objectives. The acronym VNM stands for V-algorithm using Newton Raphson method to search multiple-objective optimal design. 2023-06-16
r-tunepareto public Generic methods for parameter tuning of classification algorithms using multiple scoring functions. 2023-06-16
r-tsss public Functions for statistical analysis, modeling and simulation of time series with state space model, based on the methodology in Kitagawa (1993, ISBN: 4-00-007703-1 and 2005, ISBN: 4-00-005455-4). 2023-06-16
r-truncgof public Goodness-of-fit tests and some adjusted exploratory tools allowing for left truncated data 2023-06-16
r-tmcn public A Text mining toolkit for Chinese, which includes facilities for Chinese string processing, Chinese NLP supporting, encoding detecting and converting. Moreover, it provides some functions to support 'tm' package in Chinese. 2023-06-16
r-v8 public An R interface to Google's open source JavaScript engine. This package can now be compiled either with V8 version 6 or 7 (LTS) from nodejs or with the legacy 3.14/3.15 branch of V8. 2023-06-16
r-vetr public Declarative template-based framework for verifying that objects meet structural requirements, and auto-composing error messages when they do not. 2023-06-16
r-unidoe public Efficient procedures for constructing uniform design of experiments under various space-filling criteria. It is based on a stochastic and adaptive threshold accepting algorithm with flexible initialization, adaptive threshold, and stochastic evolution. The package may also construct the augmented uniform designs in a sequential manner. 2023-06-16
r-treeman public S4 class and methods for intuitive and efficient phylogenetic tree manipulation. 2023-06-16
r-tmg public Random number generation of truncated multivariate Gaussian distributions using Hamiltonian Monte Carlo. The truncation is defined using linear and/or quadratic polynomials. 2023-06-16
r-wbs public Provides efficient implementation of the Wild Binary Segmentation and Binary Segmentation algorithms for estimation of the number and locations of multiple change-points in the piecewise constant function plus Gaussian noise model. 2023-06-16
r-vgamextra public Extending the functionalities of the 'VGAM' package with additional functions and datasets. At present, 'VGAMextra' comprises new family functions (ffs) to estimate several time series models by maximum likelihood using Fisher scoring, unlike popular packages in CRAN relying on optim(), including ARMA-GARCH-like models, the Order-(p, d, q) ARIMAX model (non- seasonal), the Order-(p) VAR model, error correction models for cointegrated time series, and ARMA-structures with Student-t errors. For independent data, new ffs to estimate the inverse- Weibull, the inverse-gamma, the generalized beta of the second kind and the general multivariate normal distributions are available. In addition, 'VGAMextra' incorporates new VGLM-links for the mean-function, and the quantile-function (as an alternative to ordinary quantile modelling) of several 1-parameter distributions, that are compatible with the class of VGLM/VGAM family functions. Currently, only fixed-effects models are implemented. All functions are subject to change; see the NEWS for further details on the latest changes. 2023-06-16
r-validatejsonr public The current implementation uses the C++ library 'RapidJSON' to supply the schema functionality, it supports JSON Schema Draft v4. As of 2016-09-09, 'RapidJSON' passed 262 out of 263 tests in JSON Schema Test Suite (JSON Schema draft 4). 2023-06-16
r-transport public Solve optimal transport problems. Compute Wasserstein distances (a.k.a. Kantorovitch, Fortet--Mourier, Mallows, Earth Mover's, or minimal L_p distances), return the corresponding transference plans, and display them graphically. Objects that can be compared include grey-scale images, (weighted) point patterns, and mass vectors. 2023-06-16
r-tmb public With this tool, a user should be able to quickly implement complex random effect models through simple C++ templates. The package combines 'CppAD' (C++ automatic differentiation), 'Eigen' (templated matrix-vector library) and 'CHOLMOD' (sparse matrix routines available from R) to obtain an efficient implementation of the applied Laplace approximation with exact derivatives. Key features are: Automatic sparseness detection, parallelism through 'BLAS' and parallel user templates. 2023-06-16
r-tinflex public A universal non-uniform random number generator for quite arbitrary distributions with piecewise twice differentiable densities. 2023-06-16
r-ump public Does uniformly most powerful (UMP) and uniformly most powerful unbiased (UMPU) tests. At present only distribution implemented is binomial distribution. Also does fuzzy tests and confidence intervals (following Geyer and Meeden, 2005, <doi:10.1214/088342305000000340>) for the binomial distribution (one-tailed procedures based on UMP test and two-tailed procedures based on UMPU test). 2023-06-16
r-tsdfgs public Determining training set for genomic selection using a genetic algorithm (Holland J.H. (1975) <DOI:10.1145/1216504.1216510>) or simple exchange algorithm (change an individual every iteration). Three different criteria are used in both algorithms, which are r-score (Ou J.H., Liao C.T. (2018) <DOI:10.6342/NTU201802290>), PEV-score (Akdemir D. et al. (2015) <DOI:10.1186/s12711-015-0116-6>) and CD-score (Laloe D. (1993) <DOI:10.1186/1297-9686-25-6-557>). Phenotypic data for candidate set is not necessary for all these methods. By using it, one may readily determine a training set that can be expected to provide a better training set comparing to random sampling. 2023-06-16
r-timsac public Functions for statistical analysis, prediction and control of time series based mainly on Akaike and Nakagawa (1988) <ISBN 978-90-277-2786-2>. 2023-06-16
r-threearmedtrials public Design and analyze three-arm non-inferiority or superiority trials which follow a gold-standard design, i.e. trials with an experimental treatment, an active, and a placebo control. Method for the following distributions are implemented: Poisson (Mielke and Munk (2009) <arXiv:0912.4169>), negative binomial (Muetze et al. (2016) <doi:10.1002/sim.6738>), normal (Pigeot et al. (2003) <doi:10.1002/sim.1450>; Hasler et al. (2009) <doi:10.1002/sim.3052>), binary (Friede and Kieser (2007) <doi:10.1002/sim.2543>), nonparametric (Muetze et al. (2017) <doi:10.1002/sim.7176>), exponential (Mielke and Munk (2009) <arXiv:0912.4169>). 2023-06-16
r-thgenetics public A step-up test for genetic rare variants in a gene or in a pathway. The method determines an optimal grouping of rare variants analytically. The method has been described in Hoffmann TJ, Marini NJ, and Witte JS (2010) <doi:10.1371/journal.pone.0013584>. 2023-06-16
r-tfmpvalue public In putative Transcription Factor Binding Sites (TFBSs) identification from sequence/alignments, we are interested in the significance of certain match score. TFMPvalue provides the accurate calculation of P-value with score threshold for Position Weight Matrices, or the score with given P-value. It is an interface to code originally made available by Helene Touzet and Jean-Stephane Varre, 2007, Algorithms Mol Biol:2, 15. Touzet and Varre (2007) <DOI:10.1186/1748-7188-2-15>. 2023-06-16
r-vicmodel public The Variable Infiltration Capacity (VIC) model is a macroscale hydrologic model that solves full water and energy balances, originally developed by Xu Liang at the University of Washington (UW). The version of VIC source code used is of 5.0.1 on <https://github.com/UW-Hydro/VIC/>, see Hamman et al. (2018). Development and maintenance of the current official version of the VIC model at present is led by the UW Hydro (Computational Hydrology group) in the Department of Civil and Environmental Engineering at UW. VIC is a research model and in its various forms it has been applied to most of the major river basins around the world, as well as globally. If you make use of this model, please acknowledge the appropriate references listed in the help page of this package or on the references page <http://vic.readthedocs.io/en/master/Documentation/References/> of the VIC official documentation website. These should include Liang et al. (1994) plus any references relevant to the features you are using Reference: Liang, X., D. P. Lettenmaier, E. F. Wood, and S. J. Burges (1994), A simple hydrologically based model of land surface water and energy fluxes for general circulation models, J. Geophys. Res., 99(D7), 14415-14428, <doi:10.1029/94JD00483>. Hamman et al. (2018) about VIC 5.0.1 also can be considered: Hamman, J. J., Nijssen, B., Bohn, T. J., Gergel, D. R., and Mao, Y. (2018), The Variable Infiltration Capacity model version 5 (VIC-5): infrastructure improvements for new applications and reproducibility, Geosci. Model Dev., 11, 3481-3496, <doi:10.5194/gmd-11-3481-2018>. 2023-06-16
r-vdgraph public Uses a modification of the published FORTRAN code in "A Computer Program for Generating Variance Dispersion Graphs" by G. Vining, Journal of Quality Technology, Vol. 25 No. 1 January 1993, to produce variance dispersion graphs. Also produces fraction of design space plots, and contains data frames for several minimal run response surface designs. 2023-06-16
r-unfoldr public Stereological unfolding of the joint size-shape-orientation distribution of spheroidal shaped particles. 2023-06-16
r-udpipe public This natural language processing toolkit provides language-agnostic 'tokenization', 'parts of speech tagging', 'lemmatization' and 'dependency parsing' of raw text. Next to text parsing, the package also allows you to train annotation models based on data of 'treebanks' in 'CoNLL-U' format as provided at <http://universaldependencies.org/format.html>. The techniques are explained in detail in the paper: 'Tokenizing, POS Tagging, Lemmatizing and Parsing UD 2.0 with UDPipe', available at <doi:10.18653/v1/K17-3009>. 2023-06-16
r-tserieschaos public Routines for the analysis of nonlinear time series. This work is largely inspired by the TISEAN project, by Rainer Hegger, Holger Kantz and Thomas Schreiber: <http://www.mpipks-dresden.mpg.de/~tisean/>. 2023-06-16
r-tsc public Performs the two-sample comparisons using the following exact test procedures: the exact likelihood-ratio test (LRT) for equality of two normal populations proposed in Zhang et al. (2012); the combined test based on the LRT and Shapiro-Wilk test for normality via the Bonferroni correction technique; the newly proposed density-based empirical likelihood (DBEL) ratio test. To calculate p-values of the DBEL procedures, three procedures are used: (a) the traditional Monte Carlo (MC) method implemented in C++, (b) a new interpolation method based on regression techniques to operate with tabulated critical values of the test statistic; (c) a Bayesian type method that uses the tabulated critical values as the prior information and MC generated DBEL-test-statistic's values as data. 2023-06-16
r-tripack public A constrained two-dimensional Delaunay triangulation package providing both triangulation and generation of voronoi mosaics of irregular spaced data. 2023-06-16
r-transurv public A structural transformation model for a latent, quasi-independent truncation time as a function of the observed dependent truncation time and the event time, and an unknown dependence parameter. The dependence parameter is chosen to minimize the conditional Kendall's tau (Martin and Betensky, 2005) <doi:10.1198/016214504000001538>. The marginal distribution for the truncation time and the event time are completely left unspecified. 2023-06-16
r-tis public Functions and S3 classes for time indexes and time indexed series, which are compatible with FAME frequencies. 2023-06-16
r-tfcox public In Cox's proportional hazard model, covariates are modeled as linear function and may not be flexible. This package implements additive trend filtering Cox proportional hazards model as proposed in Jiacheng Wu & Daniela Witten (2019) "Flexible and Interpretable Models for Survival Data", Journal of Computational and Graphical Statistics, <DOI:10.1080/10618600.2019.1592758>. The fitted functions are piecewise polynomial with adaptively chosen knots. 2023-06-16
r-volesti public Provides an R interface for 'volesti' C++ package. 'volesti' computes estimations of volume of polytopes given by a set of points or linear inequalities or Minkowski sum of segments (zonotopes). There are two algorithms for volume estimation (I.Z. Emiris and V. Fisikopoulos (2014) <arXiv:1312.2873> and B. Cousins, S. Vempala (2016) <arXiv:1409.6011>) as well as algorithms for sampling, rounding and rotating polytopes. Moreover, 'volesti' provides algorithms for estimating copulas (L. Cales, A. Chalkis, I.Z. Emiris, V. Fisikopoulos (2018) <arXiv:1803.05861>). 2023-06-16
r-unsystation public Performs a test for second-order stationarity of time series based on unsystematic sub-samples. 2023-06-16
r-unix public Bindings to system utilities found in most Unix systems such as POSIX functions which are not part of the Standard C Library. 2023-06-16
r-trustoptim public Trust region algorithm for nonlinear optimization. Efficient when the Hessian of the objective function is sparse (i.e., relatively few nonzero cross-partial derivatives). See Braun, M. (2014) <doi:10.18637/jss.v060.i04>. 2023-06-16
r-triebeard public 'Radix trees', or 'tries', are key-value data structures optimised for efficient lookups, similar in purpose to hash tables. 'triebeard' provides an implementation of 'radix trees' for use in R programming and in developing packages with 'Rcpp'. 2023-06-16
r-timechange public Efficient routines for manipulation of date-time objects while accounting for time-zones and daylight saving times. The package includes utilities for updating of date-time components (year, month, day etc.), modification of time-zones, rounding of date-times, period addition and subtraction etc. Parts of the 'CCTZ' source code, released under the Apache 2.0 License, are included in this package. See <https://github.com/google/cctz> for more details. 2023-06-16
r-tiff public This package provides an easy and simple way to read, write and display bitmap images stored in the TIFF format. It can read and write both files and in-memory raw vectors. 2023-06-16

© 2024 Anaconda, Inc. All Rights Reserved. (v4.0.5) Legal | Privacy Policy