About Anaconda Help Download Anaconda

r / packages

Package Name Access Summary Updated
r-laf public Methods for fast access to large ASCII files. Currently the following file formats are supported: comma separated format (CSV) and fixed width format. It is assumed that the files are too large to fit into memory, although the package can also be used to efficiently access files that do fit into memory. Methods are provided to access and process files blockwise. Furthermore, an opened file can be accessed as one would an ordinary data.frame. The LaF vignette gives an overview of the functionality provided. 2025-03-25
r-landscaper public Simulates categorical maps on actual geographical realms, starting from either empty landscapes or landscapes provided by the user (e.g. land use maps). Allows to tweak or create landscapes while retaining a high degree of control on its features, without the hassle of specifying each location attribute. In this it differs from other tools which generate null or neutral landscapes in a theoretical space. The basic algorithm currently implemented uses a simple agent style/cellular automata growth model, with no rules (apart from areas of exclusion) and von Neumann neighbourhood (four cells, aka Rook case). Outputs are raster dataset exportable to any common GIS format. 2025-03-25
r-l0ara public An efficient procedure for feature selection for generalized linear models with L0 penalty, including linear, logistic, Poisson, gamma, inverse Gaussian regression. Adaptive ridge algorithms are used to fit the models. 2025-03-25
r-l1pack public L1 estimation for linear regression using Barrodale and Roberts' method <doi:10.1145/355616.361024> and the EM algorithm <doi:10.1023/A:1020759012226>, density, distribution function, quantile function and random number generation for univariate and multivariate Laplace distribution <doi:10.1080/03610929808832115>. 2025-03-25
r-kza public Time Series Analysis including break detection, spectral analysis, KZ Fourier Transforms. 2025-03-25
r-kvh public The format KVH is a lightweight format that can be read/written both by humans and machines. It can be useful in situations where XML or alike formats seem to be an overkill. We provide an ability to parse KVH files in R pretty fast due to 'Rcpp' use. 2025-03-25
r-kyotil public Helper functions for creating formatted summary of regression models, writing publication-ready tables to latex files, and running Monte Carlo experiments. 2025-03-25
r-ksgeneral public Computes a p-value of the one-sample two-sided (or one-sided, as a special case) Kolmogorov-Smirnov (KS) statistic, for any fixed critical level, and an arbitrary, possibly large sample size for a pre-specified purely discrete, mixed or continuous cumulative distribution function (cdf) under the null hypothesis. If a data sample is supplied, 'KSgeneral' computes the p-value corresponding to the value of the KS test statistic computed based on the user provided data sample. The package 'KSgeneral' implements a novel, accurate and efficient method named Exact-KS-FFT, expressing the p-value as a double-boundary non-crossing probability for a homogeneous Poisson process, which is then efficiently computed using Fast Fourier Transform (FFT). The package can also be used to compute and plot the complementary cdf of the KS statistic which is known to depend on the hypothesized distribution when the latter is discontinuous (i.e. purely discrete or mixed). To cite this package in publication use: Dimitrina S. Dimitrova, Vladimir K. Kaishev, and Senren Tan. Computing the Kolmogorov-Smirnov Distribution When the Underlying CDF is Purely Discrete, Mixed, or Continuous. Journal of Statistical Software. 2020; 95(10): 1--42. <doi:10.18637/jss.v095.i10>. 2025-03-25
r-ksnn public Prediction with k* nearest neighbor algorithm based on a publication by Anava and Levy (2016) <arXiv:1701.07266>. 2025-03-25
r-ksamples public Compares k samples using the Anderson-Darling test, Kruskal-Wallis type tests with different rank score criteria, Steel's multiple comparison test, and the Jonckheere-Terpstra (JT) test. It computes asymptotic, simulated or (limited) exact P-values, all valid under randomization, with or without ties, or conditionally under random sampling from populations, given the observed tie pattern. Except for Steel's test and the JT test it also combines these tests across several blocks of samples. Also analyzed are 2 x t contingency tables and their blocked combinations using the Kruskal-Wallis criterion. Steel's test is inverted to provide simultaneous confidence bounds for shift parameters. A plotting function compares tail probabilities obtained under asymptotic approximation with those obtained via simulation or exact calculations. 2025-03-25
r-kriging public An implementation of a simple and highly optimized ordinary kriging algorithm to plot geographical data. 2025-03-25
r-konpsurv public The K-sample omnibus non-proportional hazards (KONP) tests are powerful non-parametric tests for comparing K (>=2) hazard functions based on right-censored data (Gorfine, Schlesinger and Hsu, 2020, <doi:10.1177/0962280220907355>). These tests are consistent against any differences between the hazard functions of the groups. The KONP tests are often more powerful than other existing tests, especially under non-proportional hazard functions. 2025-03-25
r-kolmim public Provides an alternative, more efficient evaluation of extreme probabilities of Kolmogorov's goodness-of-fit measure, Dn, when compared to the original implementation of Wang, Marsaglia, and Tsang. These probabilities are used in Kolmogorov-Smirnov tests when comparing two samples. 2025-03-25
r-kodama public An unsupervised and semi-supervised learning algorithm that performs feature extraction from noisy and high-dimensional data. It facilitates identification of patterns representing underlying groups on all samples in a data set. Based on Cacciatore S, Tenori L, Luchinat C, Bennett PR, MacIntyre DA. (2017) Bioinformatics <doi:10.1093/bioinformatics/btw705> and Cacciatore S, Luchinat C, Tenori L. (2014) Proc Natl Acad Sci USA <doi:10.1073/pnas.1220873111>. 2025-03-25
r-knncat public Scale categorical variables in such a way as to make NN classification as accurate as possible. The code also handles continuous variables and prior probabilities, and does intelligent variable selection and estimation of both error rates and the right number of NN's. 2025-03-25
r-knor public The k-means 'NUMA' Optimized Routine library or 'knor' is a highly optimized and fast library for computing k-means in parallel with accelerations for Non-Uniform Memory Access ('NUMA') architectures. 2025-03-25
r-kknn public Weighted k-Nearest Neighbors for Classification, Regression and Clustering. 2025-03-25
r-kissmig public Simulating species migration and range dynamics under stable or changing environmental conditions based on a simple, raster-based, stochastic migration model. Providing accessibility from an origin or previous distribution for niche-based species distribution models. Nobis & Normand (2014) <doi:10.1111/ecog.00930>. 2025-03-25
r-kfksds public Naive implementation of the Kalman filter, smoother and disturbance smoother for state space models. 2025-03-25
r-kfas public State space modelling is an efficient and flexible framework for statistical inference of a broad class of time series and other data. KFAS includes computationally efficient functions for Kalman filtering, smoothing, forecasting, and simulation of multivariate exponential family state space models, with observations from Gaussian, Poisson, binomial, negative binomial, and gamma distributions. See the paper by Helske (2017) <doi:10.18637/jss.v078.i10> for details. 2025-03-25
r-keypress public Wait for a single key press at the 'R' prompt. This works in terminals, but does not currently work in the 'Windows' 'GUI', the 'OS X' 'GUI' ('R.app'), in 'Emacs' 'ESS', in an 'Emacs' shell buffer or in 'R Studio'. In these cases 'keypress' stops with an error message. 2025-03-25
r-kernelknn public Extends the simple k-nearest neighbors algorithm by incorporating numerous kernel functions and a variety of distance metrics. The package takes advantage of 'RcppArmadillo' to speed up the calculation of distances between observations. 2025-03-25
r-kexpmv public Implements functions from 'EXPOKIT' (<https://www.maths.uq.edu.au/expokit/>) to calculate matrix exponentials, Sidje RB, (1998) <doi:10.1145/285861.285868>. Includes functions for small dense matrices along with functions for large sparse matrices. The functions for large sparse matrices implement Krylov subspace methods which help minimise the computational complexity for matrix exponentials. 'Kexpmv' can be utilised to calculate both the matrix exponential in isolation along with the product of the matrix exponential and a vector. 2025-03-25
r-kerndwd public A novel implementation that solves the linear distance weighted discrimination and the kernel distance weighted discrimination. Reference: Wang and Zou (2018) <doi:10.1111/rssb.12244>. 2025-03-25
r-kere public An efficient algorithm inspired by majorization-minimization principle for solving the entire solution path of a flexible nonparametric expectile regression estimator constructed in a reproducing kernel Hilbert space. 2025-03-25
r-kendall public Computes the Kendall rank correlation and Mann-Kendall trend test. See documentation for use of block bootstrap when there is autocorrelation. 2025-03-25
r-kaps public This package provides some routines to conduct the K-adaptive parititioning (kaps) algorithm for survival data. A function kaps is an implementation version of our algorithm. 2025-03-25
r-kappalab public S4 tool box for capacity (or non-additive measure, fuzzy measure) and integral manipulation in a finite setting. It contains routines for handling various types of set functions such as games or capacities. It can be used to compute several non-additive integrals: the Choquet integral, the Sugeno integral, and the symmetric and asymmetric Choquet integrals. An analysis of capacities in terms of decision behavior can be performed through the computation of various indices such as the Shapley value, the interaction index, the orness degree, etc. The well-known M�bius transform, as well as other equivalent representations of set functions can also be computed. Kappalab further contains seven capacity identification routines: three least squares based approaches, a method based on linear programming, a maximum entropy like method based on variance minimization, a minimum distance approach and an unsupervised approach based on parametric entropies. The functions contained in Kappalab can for instance be used in the framework of multicriteria decision making or cooperative game theory. 2025-03-25
r-kamila public Implements methods for clustering mixed-type data, specifically combinations of continuous and nominal data. Special attention is paid to the often-overlooked problem of equitably balancing the contribution of the continuous and categorical variables. This package implements KAMILA clustering, a novel method for clustering mixed-type data in the spirit of k-means clustering. It does not require dummy coding of variables, and is efficient enough to scale to rather large data sets. Also implemented is Modha-Spangler clustering, which uses a brute-force strategy to maximize the cluster separation simultaneously in the continuous and categorical variables. For more information, see Foss, Markatou, Ray, & Heching (2016) <doi:10.1007/s10994-016-5575-7> and Foss & Markatou (2018) <doi:10.18637/jss.v083.i13>. 2025-03-25
r-jwutil public This is a set of simple utilities for various data manipulation and testing tasks. The goal is to use core R tools well, without bringing in many dependencies. Main areas of interest are semi-automated data frame manipulation, such as converting factors in multiple binary indicator columns. There are testing functions which provide 'testthat' expectations to permute arguments to function calls. There are functions and data to test extreme numbers, dates, and bad input of various kinds which should allow testing failure and corner cases, which can be used for fuzzing your functions. The test suite has many examples of usage. 2025-03-25
r-junctions public Individual based simulations of hybridizing populations, where the accumulation of junctions is tracked. Furthermore, mathematical equations are provided to verify simulation outcomes. Both simulations and mathematical equations are based on Janzen (2018, <doi:10.1101/058107>) and Janzen (2020, <doi:10.1101/2020.09.10.292441>). 2025-03-25
r-jumptest public A fast simulation on stochastic volatility model, with jump tests, p-values pooling, and FDR adjustments. 2025-03-25
r-jtgwas public The core of this 'Rcpp' based package is a function to compute standardized Jonckheere-Terpstra test statistics for large numbers of dependent and independent variables, e.g., genome-wide analysis. It implements 'OpenMP', allowing the option of computing on multiple threads. Supporting functions are also provided to calculate p-values and summarize results. 2025-03-25
r-juliacall public Provides an R interface to 'Julia', which is a high-level, high-performance dynamic programming language for numerical computing, see <https://julialang.org/> for more information. It provides a high-level interface as well as a low-level interface. Using the high level interface, you could call any 'Julia' function just like any R function with automatic type conversion. Using the low level interface, you could deal with C-level SEXP directly while enjoying the convenience of using a high-level programming language like 'Julia'. 2025-03-25
r-jrf public Simultaneous estimation of multiple related networks. 2025-03-25
r-jousboost public Implements under/oversampling for probability estimation. To be used with machine learning methods such as AdaBoost, random forests, etc. 2025-03-25
r-jointdiag public Different algorithms to perform approximate joint diagonalization of a finite set of square matrices. Depending on the algorithm, orthogonal or non-orthogonal diagonalizer is found. These algorithms are particularly useful in the context of blind source separation. Original publications of the algorithms can be found in Ziehe et al. (2004), Pham and Cardoso (2001) <doi:10.1109/78.942614>, Souloumiac (2009) <doi:10.1109/TSP.2009.2016997>, Vollgraff and Obermayer <doi:10.1109/TSP.2006.877673>. An example of application in the context of Brain-Computer Interfaces EEG denoising can be found in Gouy-Pailler et al (2010) <doi:10.1109/TBME.2009.2032162>. 2025-03-25
r-jmotif public Implements time series z-normalization, SAX, HOT-SAX, VSM, SAX-VSM, RePair, and RRA algorithms facilitating time series motif (i.e., recurrent pattern), discord (i.e., anomaly), and characteristic pattern discovery along with interpretable time series classification. 2025-03-25
r-jmi public Computes the Jackknife Mutual Information (JMI) between two random vectors and provides the p-value for dependence tests. See Zeng, X., Xia, Y. and Tong, H. (2018) <doi:10.1073/pnas.1715593115>. 2025-03-25
r-jade public Cardoso's JADE algorithm as well as his functions for joint diagonalization are ported to R. Also several other blind source separation (BSS) methods, like AMUSE and SOBI, and some criteria for performance evaluation of BSS algorithms, are given. The package is described in Miettinen, Nordhausen and Taskinen (2017) <doi:10.18637/jss.v076.i02>. 2025-03-25
r-jmdl public Fit joint mean-correlation models for discrete longitudinal data (Tang CY,Zhang W, Leng C, 2017 <doi:10.5705/ss.202016.0435>). 2025-03-25
r-jaguar public Implements a novel score test that measures 1) the overall shift in the gene expression due to genotype (additive genetic effect), and 2) group-specific changes in gene expression due to genotype (interaction effect) in a mixed-effects model framework. 2025-03-25
r-jaspar public R modules for JASPAR data processing and visualization 2025-03-25
r-itree public This package is based on the code of the rpart package. It extends rpart by adding additional splitting methods emphasizing interpretable/parsimonious trees. Unless indicated otherwise, it is safe to assume that all functions herein are extensions of or copied directly from similar or nearly identical rpart methods. As such, the authors of rpart are authors of this package as well. However, please direct any error reports or other questions about itree to the maintainer of this package; they are welcome and appreciated. 2025-03-25
r-jacobieigen public Implements the classical Jacobi algorithm for the eigenvalues and eigenvectors of a real symmetric matrix, both in pure 'R' and in 'C++' using 'Rcpp'. Mainly as a programming example for teaching purposes. 2025-03-25
r-isr3 public Performs multivariate normal imputation through iterative sequential regression. Conditional dependency structure between imputed variables can be specified a priori to accelerate imputation. 2025-03-25
r-itrlearn public Maximin-projection learning (MPL, Shi, et al., 2018) is implemented for recommending a meaningful and reliable individualized treatment regime for future groups of patients based on the observed data from different populations with heterogeneity in individualized decision making. Q-learning and A-learning are implemented for estimating the groupwise contrast function that shares the same marginal treatment effects. The packages contains classical Q-learning and A-learning algorithms for a single stage study as a byproduct. More functions will be added at later versions. 2025-03-25
r-isoband public A fast C++ implementation to generate contour lines (isolines) and contour polygons (isobands) from regularly spaced grids containing elevation data. 2025-03-25
r-isospecr public IsoSpec is a fine structure calculator used for obtaining the most probable masses of a chemical compound given the frequencies of the composing isotopes and their masses. It finds the smallest set of isotopologues with a given probability. The probability is assumed to be that of the product of multinomial distributions, each corresponding to one particular element and parametrized by the frequencies of finding these elements in nature. These numbers are supplied by IUPAC - the International Union of Pure and Applied Chemistry. See: Lacki, Valkenborg, Startek (2020) <DOI:10.1021/acs.analchem.0c00959> and Lacki, Startek, Valkenborg, Gambin (2017) <DOI:10.1021/acs.analchem.6b01459> for the description of the algorithms used. 2025-03-25
r-isqg public Accomplish high performance simulations in quantitative genetics. The molecular genetic components are represented by R6/C++ classes and methods. The core computational algorithm is implemented using bitsets according to <doi:10.1534/g3.119.400373>. A mix between low and high level interfaces provides great flexibility and allows user defined extensions and a wide range of applications. 2025-03-25

© 2025 Anaconda, Inc. All Rights Reserved. (v4.0.9) Legal | Privacy Policy