r-cprr
|
public |
Calculate date of birth, age, and gender, and generate anonymous sequence numbers from CPR numbers. <https://en.wikipedia.org/wiki/Personal_identification_number_(Denmark)>.
|
2023-06-16 |
r-cpk
|
public |
The package cpk provides simplified clinical pharmacokinetic functions for dose regimen design and modification at the point-of-care. Currently, the following functions are available: (1) ttc.fn for target therapeutic concentration, (2) dr.fn for dose rate, (3) di.fn for dosing interval, (4) dm.fn for maintenance dose, (5) bc.ttc.fn for back calculation, (6) ar.fn for accumulation ratio, (7) dpo.fn for orally administered dose, (8) cmax.fn for peak concentration, (9) css.fn for steady-state concentration, (10) cmin.fn for trough,(11) ct.fn for concentration-time predictions, (12) dlcmax.fn for calculating loading dose based on drug's maximum concentration, (13) dlar.fn for calculating loading dose based on drug's accumulation ratio, and (14) R0.fn for calculating drug infusion rate. Reference: Linares O, Linares A. Computational opioid prescribing: A novel application of clinical pharmacokinetics. J Pain Palliat Care Pharmacother 2011;25:125-135.
|
2023-06-16 |
r-coxphsgd
|
public |
Estimate coefficients of Cox proportional hazards model using stochastic gradient descent algorithm for batch data.
|
2023-06-16 |
r-cpm
|
public |
Sequential and batch change detection for univariate data streams, using the change point model framework. Functions are provided to allow nonparametric distribution-free change detection in the mean, variance, or general distribution of a given sequence of observations. Parametric change detection methods are also provided for Gaussian, Bernoulli and Exponential sequences. Both the batch (Phase I) and sequential (Phase II) settings are supported, and the sequences may contain either a single or multiple change points.
|
2023-06-16 |
r-correctoverloadedpeaks
|
public |
Analyzes and modifies metabolomics raw data (generated using GC-APCI-MS, Gas Chromatography-Atmospheric Pressure Chemical Ionization-Mass Spectrometry) to correct overloaded signals, i.e. ion intensities exceeding detector saturation leading to a cut-off peak. Data in xcmsRaw format are accepted as input and mzXML files can be processed alternatively. Overloaded signals are detected automatically and modified using an Gaussian or Isotopic-Ratio approach, QC plots are generated and corrected data are stored within the original xcmsRaw or mzXML respectively to allow further processing.
|
2023-06-16 |
r-corporacoco
|
public |
A set of functions used to compare co-occurrence between two corpora.
|
2023-06-16 |
r-core
|
public |
given a collection of intervals with integer start and end positions, find recurrently targeted regions and estimate the significance of finding. Randomization is implemented by parallel methods, either using local host machines, or submitting grid engine jobs.
|
2023-06-16 |
r-confintvariance
|
public |
Surrounds the usual sample variance of a univariate numeric sample with a confidence interval for the population variance. This has been done so far only under the assumption that the underlying distribution is normal. Under the hood, this package implements the unique least-variance unbiased estimator of the variance of the sample variance, in a formula that is equivalent to estimating kurtosis and square of the population variance in an unbiased way and combining them according to the classical formula into an estimator of the variance of the sample variance. Both the sample variance and the estimator of its variance are U-statistics. By the theory of U-statistic, the resulting estimator is unique. See Fuchs, Krautenbacher (2016) <doi:10.1080/15598608.2016.1158675> and the references therein for an overview of unbiased estimation of variances of U-statistics.
|
2023-06-16 |
r-conf.design
|
public |
This small library contains a series of simple tools for constructing and manipulating confounded and fractional factorial designs.
|
2023-06-16 |
r-compactr
|
public |
Creates empty plots with compact axis notation to which users can add whatever they like (points, lines, text, etc.) The notation is more compact in the sense that the axis-labels and tick-labels are closer to the axis and the tick-marks are shorter. Also, if the plot appears as part of a matrix, the x-axis notation is suppressed unless the plot appears along the bottom row and the y-axis notation is suppress unless the plot appears along the left column.
|
2023-06-16 |
r-comparer
|
public |
Quickly run experiments to compare the run time and output of code blocks. The function mbc() can make fast comparisons of code, and will calculate statistics comparing the resulting outputs. It can be used to compare model fits to the same data or see which function runs faster. The function ffexp() runs a function using all possible combinations of selected inputs. This is useful for comparing the effect of different parameter values. It can also run in parallel and automatically save intermediate results, which is very useful for long computations.
|
2023-06-16 |
r-compareodm
|
public |
Input: 2 ODM files (ODM version 1.3) Output: list of identical, matching, similar and differing data items
|
2023-06-16 |
r-cnorm
|
public |
Conventional methods for producing standard scores in psychometrics or biometrics are often plagued with "jumps" or "gaps" (i.e., discontinuities) in norm tables and low confidence for assessing extreme scores. The continuous norming method introduced by A. Lenhard et al. (2016), <doi:10.1177/1073191116656437>, generates continuous test norm scores on the basis of the raw data from standardization samples, without requiring assumptions about the distribution of the raw data: Norm scores are directly established from raw data by modeling the latter ones as a function of both percentile scores and an explanatory variable (e.g., age). The method minimizes bias arising from sampling and measurement error, while handling marked deviations from normality, addressing bottom or ceiling effects and capturing almost all of the variance in the original norm data sample.
|
2023-06-16 |
r-circmle
|
public |
A series of wrapper functions to implement the 10 maximum likelihood models of animal orientation described by Schnute and Groot (1992) <DOI:10.1016/S0003-3472(05)80068-5>. The functions also include the ability to use different optimizer methods and calculate various model selection metrics (i.e., AIC, AICc, BIC).
|
2023-06-16 |
r-collutils
|
public |
Provides some low level functions for processing PLINK input and output files.
|
2023-06-16 |
r-clustvarlv
|
public |
Functions for the clustering of variables around Latent Variables, for 2-way or 3-way data. Each cluster of variables, which may be defined as a local or directional cluster, is associated with a latent variable. External variables measured on the same observations or/and additional information on the variables can be taken into account. A "noise" cluster or sparse latent variables can also be defined.
|
2023-06-16 |
r-commonjavajars
|
public |
Useful libraries for building a Java based GUI under R are provided.
|
2023-06-16 |
r-comf
|
public |
Functions to calculate various common and less common thermal comfort indices, convert physical variables, and evaluate the performance of thermal comfort indices.
|
2023-06-16 |
r-combinepvalue
|
public |
We offer two statistical tests to combine p-values: selfcontained.test vs competitive.test. The goal is to test whether a vector of pvalues are jointly significant when we combine them together.
|
2023-06-16 |
r-colorpalette
|
public |
Different methods to generate a color palette based on a specified base color and a number of colors that should be created.
|
2023-06-16 |
r-cofad
|
public |
Contrast analysis for factorial designs is an alternative to the classical ANOVA approach with the advantage of testing focused hypothesis. The method is mainly based on Rosenthal, Rosnow and Rubin (2000, ISBN:978-0521659802) and Sedlmeier and Renkewitz (2018, ISBN:978-3868943214).
|
2023-06-16 |
r-cobiclust
|
public |
Implementation of a probabilistic method for biclustering adapted to overdispersed count data. It is a Gamma-Poisson Latent Block Model. It also implements two selection criteria in order to select the number of biclusters.
|
2023-06-16 |
r-clustsig
|
public |
A complimentary package for use with hclust; simprof tests to see which (if any) clusters are statistically different. The null hypothesis is that there is no a priori group structure. See Clarke, K.R., Somerfield, P.J., and Gorley R.N. 2008. Testing of null hypothesis in exploratory community analyses: similarity profiles and biota-environment linkage. J. Exp. Mar. Biol. Ecol. 366, 56-69.
|
2023-06-16 |
r-circoutlier
|
public |
Detection of outliers in circular-circular regression models, modifying its and estimating of models parameters.
|
2023-06-16 |
r-cmprsk
|
public |
Estimation, testing and regression modeling of subdistribution functions in competing risks, as described in Gray (1988), A class of K-sample tests for comparing the cumulative incidence of a competing risk, Ann. Stat. 16:1141-1154 <DOI:10.1214/aos/1176350951>, and Fine JP and Gray RJ (1999), A proportional hazards model for the subdistribution of a competing risk, JASA, 94:496-509, <DOI:10.1080/01621459.1999.10474144>.
|
2023-06-16 |
r-clarifai
|
public |
Get description of images from Clarifai API. For more information, see <http://clarifai.com>. Clarifai uses a large deep learning cloud to come up with descriptive labels of the things in an image. It also provides how confident it is about each of the labels.
|
2023-06-16 |
r-citbcmst
|
public |
This package implements the approach to assign tumor gene expression dataset to the 6 CIT Breast Cancer Molecular Subtypes described in Guedj et al 2012.
|
2023-06-16 |
r-cir
|
public |
Isotonic regression (IR), as well as a great small-sample improvement to IR called CIR, interval estimates for both, and additional utilities.
|
2023-06-16 |
r-ciee
|
public |
In many studies across different disciplines, detailed measures of the variables of interest are available. If assumptions can be made regarding the direction of effects between the assessed variables, this has to be considered in the analysis. The functions in this package implement the novel approach CIEE (causal inference using estimating equations; Konigorski et al., 2018, <DOI:10.1002/gepi.22107>) for estimating and testing the direct effect of an exposure variable on a primary outcome, while adjusting for indirect effects of the exposure on the primary outcome through a secondary intermediate outcome and potential factors influencing the secondary outcome. The underlying directed acyclic graph (DAG) of this considered model is described in the vignette. CIEE can be applied to studies in many different fields, and it is implemented here for the analysis of a continuous primary outcome and a time-to-event primary outcome subject to censoring. CIEE uses estimating equations to obtain estimates of the direct effect and robust sandwich standard error estimates. Then, a large-sample Wald-type test statistic is computed for testing the absence of the direct effect. Additionally, standard multiple regression, regression of residuals, and the structural equation modeling approach are implemented for comparison.
|
2023-06-16 |
r-comics
|
public |
Provided are Computational methods for Immune Cell-type Subsets, including:(1) DCQ (Digital Cell Quantifier) to infer global dynamic changes in immune cell quantities within a complex tissue; and (2) VoCAL (Variation of Cell-type Abundance Loci) a deconvolution-based method that utilizes transcriptome data to infer the quantities of immune-cell types, and then uses these quantitative traits to uncover the underlying DNA loci.
|
2023-06-16 |
r-collesslike
|
public |
Computation of Colless-Like, Sackin and cophenetic balance indices of a phylogenetic tree and study of the distribution of these balance indices under the alpha-gamma model. For more details see A. Mir, F. Rossello, L. Rotger (2013) <doi:10.1016/j.mbs.2012.10.005>, M. J. Sackin (1972) <doi:10.1093/sysbio/21.2.225>, D. H. Colless (1982) <doi:10.2307/2413420>.
|
2023-06-16 |
r-cmaes
|
public |
Single objective optimization using a CMA-ES.
|
2023-06-16 |
r-clusterrepro
|
public |
This is a function for validating microarray clusters via reproducibility, based on the paper referenced below.
|
2023-06-16 |
r-cluer
|
public |
CLUster Evaluation (CLUE) is a computational method for identifying optimal number of clusters in a given time-course dataset clustered by cmeans or kmeans algorithms and subsequently identify key kinases or pathways from each cluster. Its implementation in R is called ClueR. See README on <https://github.com/PengyiYang/ClueR> for more details. P Yang et al. (2015) <doi:10.1371/journal.pcbi.1004403>.
|
2023-06-16 |
r-commontrend
|
public |
Directly extract and plot stochastic common trends from a cointegration system using different approaches, currently including Kasa (1992) and Gonzalo and Granger (1995). The approach proposed by Gonzalo and Granger, also known as Permanent-Transitory Decomposition, is widely used in macroeconomics and market microstructure literature. Kasa's approach, on the other hand, has a nice property that it only uses the super consistent estimator: the cointegration vector 'beta'. This package also provides functions calculate P-value from Johansen Statistics according to the approximation method proposed by Doornik (1998). Update: 0.7-1: Fix bugs in calculation alpha. Add formulas and more explanations. 0.6-1: Rewrite the description file. 0.5-1: Add functions to calculate P-value from Johansen statistic, and vice versa.
|
2023-06-16 |
r-colorramps
|
public |
Builds gradient color maps
|
2023-06-16 |
r-colorhcplot
|
public |
Build dendrograms with sample groups highlighted by different colors. Visualize results of hierarchical clustering analyses as dendrograms whose leaves and labels are colored according to sample grouping. Assess whether data point grouping aligns to naturally occurring clusters.
|
2023-06-16 |
r-collectargs
|
public |
We often want to take all (or most) of the objects in one environment (such as the parameter values of a function) and pass them to another. This might be calling a second function, or iterating over a list, calling the same function. These functions wrap often repeated code. Current stable version (committed on October 14, 2017).
|
2023-06-16 |
r-coenocliner
|
public |
Simulate species occurrence and abundances (counts) along gradients.
|
2023-06-16 |
r-codina
|
public |
Categorize links and nodes from multiple networks in 3 categories: Common links (alpha) specific links (gamma), and different links (beta). Also categorizes the links into sub-categories and groups. The package includes a visualization tool for the networks. More information about the methodology can be found at: Gysi et. al., 2018 <arXiv:1802.00828>.
|
2023-06-16 |
r-cmce
|
public |
Implements the Bayesian calibration model described in Pratola and Chkrebtii (2018) <DOI:10.5705/ss.202016.0403> for stochastic and deterministic simulators. Additive and multiplicative discrepancy models are currently supported. See <http://www.matthewpratola.com/software> for more information and examples.
|
2023-06-16 |
r-binseqtest
|
public |
For a series of binary responses, create stopping boundary with exact results after stopping, allowing updating for missing assessments.
|
2023-06-16 |
r-code
|
public |
Generates all necessary C functions allowing the user to work with the compiled-code interface of ode() and bvptwp(). The implementation supports "forcings" and "events". Also provides functions to symbolically compute Jacobians, sensitivity equations and adjoint sensitivities being the basis for sensitivity analysis.
|
2023-06-16 |
r-clusternor
|
public |
The clustering 'NUMA' Optimized Routines package or 'clusternor' is a highly optimized package for performing clustering in parallel with accelerations specifically targeting multi-core Non-Uniform Memory Access ('NUMA') hardware architectures. Disa Mhembere, Da Zheng, Carey E. Priebe, Joshua T. Vogelstein, Randal Burns (2019) <arXiv:1902.09527>.
|
2023-06-16 |
r-clttools
|
public |
Central limit theorem experiments presented by data frames or plots. Functions include generating theoretical sample space, corresponding probability, and simulated results as well.
|
2023-06-16 |
r-clickclustcont
|
public |
Provides an expectation maximization (EM) algorithm to fit a mixture of continuous time Markov models for use with clickstream or other sequence type data. Gallaugher, M.P.B and McNicholas, P.D. (2018) <arXiv:1802.04849>.
|
2023-06-16 |
r-cleandata
|
public |
Functions to work with data frames to prepare data for further analysis. The functions for imputation, encoding, partitioning, and other manipulation can produce log files to keep track of process.
|
2023-06-16 |
r-classifly
|
public |
Given $p$-dimensional training data containing $d$ groups (the design space), a classification algorithm (classifier) predicts which group new data belongs to. Generally the input to these algorithms is high dimensional, and the boundaries between groups will be high dimensional and perhaps curvilinear or multi-faceted. This package implements methods for understanding the division of space between the groups.
|
2023-06-16 |
r-clinutidna
|
public |
This package provides the estimation of an index measuring the clinical utility of DNA testing in the context of gene-environment interactions on a disease. The corresponding gene-environment interaction effect on the additive scale can also be obtained. The estimation is based on case-control or cohort data. The method was developed by Nguyen et al. 2013.
|
2023-06-16 |
r-ciaawconsensus
|
public |
Calculation of consensus values for atomic weights, isotope amount ratios, and isotopic abundances with the associated uncertainties using multivariate meta-regression approach for consensus building.
|
2023-06-16 |