Results per Page:  
Search in: R Manuals Base Packages Help Pages | CRAN Task Views
CRAN Packages Description Help Pages News Readme Vignettes

Matching any words Matching all words
1-100 of about 280 matches
Term frequencies: winsorized: 285
Search took 0.001556 seconds

Size: 1.9K
R: Winsorize a vector.
...winsorization (e.g., 0.01 gives 1%) p_high Optional upper level for winsorization (e.g., 0.99 gives 99%) Value vector Examples winsorized <- winsorize(1:100, prob = 0.05) min(winsorized, na.rm = TRUE) ...
/CRAN/refmans/farr/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 1.7K
R: Winsorize or trim variables
winsorize {OOS} R Documentation Winsorize or trim variables Description Winsorize or trim variables Usage winsorize(X, bounds, trim = FALSE) Arguments X numeric: vector to be winsorized or trimmed...
/CRAN/refmans/OOS/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 1.8K
R: Winsorize Data
winsorize {PCRA} R Documentation Winsorize Data Description This function Winsorizes a fraction gamma of a numeric data set. Usage winsorize(x, fraction = 0.1) Arguments x A numeric data set fraction...
/CRAN/refmans/PCRA/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 2.0K
R: Winsorize a Numeric Vector
...winsorize(x, cut) Arguments x A numeric vector to be winsorized. cut The proportion of data to be winsorized from both ends of the distribution. For example, a cut of 0.05 will winsorize the lowest...
/CRAN/refmans/tidyfinance/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 2.6K
R: Winsorize a numeric vector
winsorize {statar} R Documentation Winsorize a numeric vector Description Winsorize a numeric vector Usage winsorize( x, probs = NULL, cutpoints = NULL, replace = c(cutpoints[1], cutpoints[2]), verbose...
/CRAN/refmans/statar/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 2.2K
R: Outliers: Winsorize
winsorize {lares} R Documentation Outliers: Winsorize Description Winsorizing a vector means that a predefined quantum of the smallest and/or the largest values are replaced by less extreme values.
/CRAN/refmans/lares/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 1.5K
R: Winsorizes the data
winsor {rrscale} R Documentation Winsorizes the data Description Winsorizes the data Usage winsor(x, fraction = 0.01) Arguments x the data. fraction the top and bottom quantiles to cap. Examples Y...
/CRAN/refmans/rrscale/html/winsor.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 1.7K
R: Winsorize a vector
winsorize {broman} R Documentation Winsorize a vector Description For a numeric vector, move values below and above the q and 1-q quantiles to those quantiles. Usage winsorize(x, q = 0.006)...
/CRAN/refmans/broman/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 2.0K
R: Winsorization of Time Series
ts_fil_winsor {tspredit} R Documentation Winsorization of Time Series Description This code implements the Winsorization technique on a time series. Winsorization is a statistical method used to handle...
/CRAN/refmans/tspredit/html/ts_fil_winsor.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 2.3K
R: Winsorize based on the absolute median deviation
...to be winsorized based on the MAD. criteria How many MAD to use as threshold (similar to standard deviations) Details For the easystats equivalent, use: datawizard::winsorize(x, method = "zscore", ...
/CRAN/refmans/rempsyc/html/winsorize_mad.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 3.3K
R: Winsorized correlation test (for paired data)
...for association between paired samples, using winsorized correlation coefficient. Usage winsor.cor.test(x, ...) ## Default S3 method: winsor.cor.test(x, y, tr=0.2,alternative = c("two.sided", "less"...
/CRAN/refmans/PairedData/html/winsor.cor.test.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 3.2K
R: Winsorize transformation
winsorize {spatialEco} R Documentation Winsorize transformation Description Removes extreme outliers using a winsorization transformation Usage winsorize( x, min.value = NULL, max.value = NULL, p = c...
/CRAN/refmans/spatialEco/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 3.5K
R: Winsorize Numeric Data
winsors {quest} R Documentation Winsorize Numeric Data Description winsors winsorizes numeric data by recoding extreme values as a user identified boundary value, which is defined by z-score units.
/CRAN/refmans/quest/html/winsors.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 3.2K
R: Find the Winsorized scores, means, sds or variances for a...
...Winsorized scores. The top and bottom trim values are given values of the trimmed and 1- trimmed quantiles. Then means, sds, and variances are found. Usage winsor(x, trim = 0.2, na.rm = TRUE) winsor...
/CRAN/refmans/psych/html/winsor.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 3.8K
R: Winsorize a Numeric Vector
winsor {quest} R Documentation Winsorize a Numeric Vector Description winsor winsorizes a numeric vector by recoding extreme values as a user-identified boundary value, which is defined by z-score...
/CRAN/refmans/quest/html/winsor.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 3.9K
R: Winsorize (Replace Extreme Values by Less Extreme Ones)
Winsorize {DescTools} R Documentation Winsorize (Replace Extreme Values by Less Extreme Ones) Description Winsorizing a vector means that a predefined quantum of the smallest and/or the largest values...
/CRAN/refmans/DescTools/html/Winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 6.7K
R: Winsorize data
winsorize {datawizard} R Documentation Winsorize data Description Winsorize data Usage winsorize(data, ...) ## S3 method for class 'numeric' winsorize( data, threshold = 0.2, method = "percentile"...
/CRAN/refmans/datawizard/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 6.6K
R: Weighted Winsorized Mean and Total (bare-bone functions)
...Weighted Winsorized Mean and Total (bare-bone functions) Description Weighted winsorized mean and total (bare-bone functions with limited functionality; see svymean_winsorized and svytotal_winsorized...
/CRAN/refmans/robsurvey/html/weighted_mean_winsorized.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 3.4K
R: Winsorized binning
...Winsorized binning Description Bin continuous data using winsorized method. Usage rbin_winsorize( data = NULL, response = NULL, predictor = NULL, bins = 10, include_na = TRUE, winsor_rate = 0.05...
/CRAN/refmans/rbin/html/rbin_winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 8.2K
R: Weighted Winsorized Mean and Total
...Winsorized Mean and Total Description Weighted winsorized mean and total Usage svymean_winsorized(x, design, LB = 0.05, UB = 1 - LB, na.rm = FALSE, trim_var = FALSE) svymean_k_winsorized(x, design, k...
/CRAN/refmans/robsurvey/html/svymean_winsorized.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 6.1K
R: Data cleaning by winsorization
...winsorization, i.e., by shrinking outlying observations to the border of the main part of the data. Usage winsorize(x, ...) ## Default S3 method: winsorize( x, standardized = FALSE, centerFun = median...
/CRAN/refmans/robustHD/html/winsorize.html
 cran-help  matching: winsorized, winsorized and winsorized


Size: 2.1K
R: Winsorize data
...to be Winsorized in each tail of an ordered dataset. Details In Winsorization we we replace responses that are not in the central 1 - 2\lambda part of an ordered sample with the minimum and maximum...
/CRAN/refmans/asbio/html/win.html
 cran-help  matching: winsorized and winsorized


Size: 2.3K
R: Winsorized variance
win_var {robnptests} R Documentation Winsorized variance Description win_var calculates the winsorized variance of a sample. Usage win_var(x, gamma = 0, na.rm = FALSE) Arguments x a (non-empty) numeric...
/CRAN/refmans/robnptests/html/win_var.html
 cran-help  matching: winsorized and winsorized


Size: 2.8K
R: Winsorize at specified percentiles
winsorizor {JWileymisc} R Documentation Winsorize at specified percentiles Description Simple function winsorizes data at the specified percentile. Usage winsorizor(d, percentile, values, na.rm = TRUE)...
/CRAN/refmans/JWileymisc/html/winsorizor.html
 cran-help  matching: winsorized and winsorized


Size: 1.7K
R: Winsorized Mean
winsorMean {PCRA} R Documentation Winsorized Mean Description Winsorized Mean Usage winsorMean(x, winFrac = 0, na.rm = FALSE, ...) Arguments x Numeric vector winFrac Fraction of data to be Winsorized...
/CRAN/refmans/PCRA/html/winsorMean.html
 cran-help  matching: winsorized and winsorized


Size: 2.1K
R: Winsorized mean
win_mean {robnptests} R Documentation Winsorized mean Description win_mean calculates the winsorized mean of a sample. Usage win_mean(x, gamma = 0.2, na.rm = FALSE) Arguments x a (non-empty) numeric...
/CRAN/refmans/robnptests/html/win_mean.html
 cran-help  matching: winsorized and winsorized


Size: 5.8K
R: Robust correlation based on winsorization
...based on winsorization Description Compute a robust correlation estimate based on winsorization, i.e., by shrinking outlying observations to the border of the main part of the data. Usage corHuber( x...
/CRAN/refmans/robustHD/html/corHuber.html
 cran-help  matching: winsorized and winsorized


Size: 2.2K
R: Winsorize outliers based on z-score cutoff to next most...
winsorZ {scipub} R Documentation Winsorize outliers based on z-score cutoff to next most extreme non-outlier value Description The winsorZ function identifies outliers based on Z-score cutoff...
/CRAN/refmans/scipub/html/winsorZ.html
 cran-help  matching: winsorized and winsorized


Size: 4.0K
R: Winsorization followed by imputation
...Winsorization of outliers according to the Mahalanobis distance followed by an imputation under the multivariate normal model. Only the outliers are winsorized. The Mahalanobis distance MDmiss allows...
/CRAN/refmans/modi/html/Winsimp.html
 cran-help  matching: winsorized and winsorized


Size: 2.5K
R: Winsorize
...{transx} R Documentation Winsorize Description Replace extremely values that are defined by min and max. Usage out_winsorise(x, min = quantile(x, 0.05), max = quantile(x, 0.95)) out_winsorize(x, min...
/CRAN/refmans/transx/html/out_winsorise.html
 cran-help  matching: winsorized and winsorized


Size: 3.2K
R: Detection and winsorization of multivariate outliers
...winsorization of multivariate outliers Description Imputation and detection of outliers Usage mvTopCoding(x, maha = NULL, center = NULL, cov = NULL, alpha = 0.025) Arguments x an object coercible to...
/CRAN/refmans/sdcMicro/html/mvTopCoding.html
 cran-help  matching: winsorized and winsorized


Size: 6.0K
R: Winsorized Mean Forecast Combination
...Winsorized Mean Forecast Combination Description Computes a ‘combined forecast’ from a pool of individual model forecasts using winsorized mean at each point in time. Usage comb_WA(x, trim_factor...
/CRAN/refmans/ForecastComb/html/comb_WA.html
 cran-help  matching: winsorized and winsorized


Size: 6.0K
R: Winsorized Mean Forecast Combination
...Winsorized Mean Forecast Combination Description Computes a ‘combined forecast’ from a pool of individual model forecasts using winsorized mean at each point in time. Usage comb_WA(x, trim_factor...
/CRAN/refmans/GeomComb/html/comb_WA.html
 cran-help  matching: winsorized and winsorized


Size: 4.8K
R: Expectation and Variance of Log Winsorized _F_ Distribution
...and Variance of Log Winsorized F Distribution Description mean_var_logwinf calculates the expectation and variance of a log Winsorized F distribution by appealing to methods for numerical integration.
/CRAN/refmans/MAnorm2/html/mean_var_logwinf.html
 cran-help  matching: winsorized and winsorized


Size: 2.2K
R: Identify outliers based on z-score cutoff that are Winsorized...
...cutoff that are Winsorized by the winsorZ function Description The winsorZ_find function is an optional companion to the winsorZ function. The winsorZ function identifies Z-score outliers and replaces...
/CRAN/refmans/scipub/html/winsorZ_find.html
 cran-help  matching: winsorized and winsorized


Size: 2.1K
R: Sets the ncol(mat)*trim top outliers in each row to the next...
...each row to the next lowest value same for the lowest outliers Usage winsorize.matrix(mat, trim) Arguments mat Numeric matrix trim numeric Fraction of outliers (on each side) that should be Winsorized...
/CRAN/refmans/pagoda2/html/winsorize.matrix.html
 cran-help  matching: winsorized and winsorized


Size: 6.9K
R: Trim (Winsorize) Large Weights
...Trim (Winsorize) Large Weights Description Trims (i.e., winsorizes) large weights by setting all weights higher than that at a given quantile to the weight at the quantile or to 0. This can be useful...
/CRAN/refmans/WeightIt/html/trim.html
 cran-help  matching: winsorized and winsorized


Size: 2.2K
R: qqnormDatWindat
...Normal QQPlot of data and Winsorized data Usage qqnormDatWindat( dat, windat, fraction = 0.01, ylim = NULL, main = main, facName = NULL ) Arguments dat Numeric data vector windat Numeric Winsorized...
/CRAN/refmans/PCRA/html/qqnormDatWindat.html
 cran-help  matching: winsorized


Size: 2.4K
R: Function post_bmr
...draw. weights_bmr An object of class 'tweights_bmr' created using the 'tweights_bmr' function. Value A matrix of simulations from the posterior. See Also tweights_bmr Examples #Use winsorized marginal...
/CRAN/refmans/tboot/html/post_bmr.html
 cran-help  matching: winsorized


Size: 3.9K
R: Prepare distance scores on data in preparation for composite...
...winsorize = 0, values, better = TRUE, covmat, standardize = TRUE, use.prethreshold = FALSE ) Arguments object An object of class ‘CompositeData’. winsorize Whether to winsorize the data or not.
/CRAN/refmans/pscore/html/prepareComposite.html
 cran-help  matching: winsorized


Size: 14.0K
R: A linear Model-based Permutation Test for Differential...
...Differential Abundance Analysis of Microbiome Data and Other Omics Data Description ZicoSeq is a permutation test (Smith permutation) for differential abundance analysis of microbiome sequencing data.
/CRAN/refmans/GUniFrac/html/ZicoSeq.html
 cran-help  matching: winsorized


Size: 4.4K
R: Robust location measures and their standard errors (se).
...winmean for the Winsorized mean, winse for its se, trimse for the trimmend mean se, msmedse for the median se, mest for the M-estimator with se in mestse. The functions onestep and mom compute the...
/CRAN/refmans/WRS2/html/trimse.html
 cran-help  matching: winsorized


Size: 3.1K
R: Function to compare evzinb or evinb models with zinb and nb...
...to compare evzinb or evinb models with zinb and nb models Usage compare_models( object, nb_comparison = TRUE, zinb_comparison = TRUE, winsorize = FALSE, razorize = FALSE, cutoff_value = 10, init_theta...
/CRAN/refmans/evinf/html/compare_models.html
 cran-help  matching: winsorized


Size: 3.1K
R: Function tboot_bmr
...Bootstrap nrow rows of dataset using the given row-level weights. Usage tboot_bmr(nrow, weights_bmr, tol_rel_sd = 0.01) Arguments nrow Number of rows in the new bootstrapped dataset. weights_bmr An...
/CRAN/refmans/tboot/html/tboot_bmr.html
 cran-help  matching: winsorized


Size: 3.3K
R: Wrapper Functions for terms in gpe
.../0.4) eTerm(x, scale = 1/0.4) Arguments x Input symbol. lb Lower quantile when winsorizing. -Inf yields no winsorizing in the lower tail. ub Lower quantile when winsorizing. Inf yields no winsorizing...
/CRAN/refmans/pre/html/rTerm.html
 cran-help  matching: winsorized


Size: 4.7K
R: Transform tails of distribution
...Arguments f A pdqr-function. level Cutoff level. For direction "both" should be between 0 and 0.5; for "left" and "right" - between 0 and 1. method Modification method. One of "trim" or "winsor".
/CRAN/refmans/pdqr/html/form_tails.html
 cran-help  matching: winsorized


Size: 2.0K
R: Truncate a vector.
...winsorized prob Level (two-sided) for winsorization (e.g., 0.01 gives 1% and 99%) p_low Optional lower level for winsorization (e.g., 0.01 gives 1%) p_high Optional upper level for winsorization (e.g...
/CRAN/refmans/farr/html/truncate.html
 cran-help  matching: winsorized


Size: 5.3K
R: Upper limit of the penalty parameter for 'family="binomial"'
...bivariate winsorization to estimate the smallest value of the upper limit for the penalty parameter. Usage lambda00(x,y,normalize=TRUE,intercept=TRUE,const=2,prob=0.95, tol=.Machine$double.eps^0.5,eps...
/CRAN/refmans/enetLTS/html/lambda00.html
 cran-help  matching: winsorized


Size: 4.5K
R: Welch's Heteroscedastic F Test and Welch's Heteroscedastic F...
...Winsorized Variances Description welch.test performs Welch's heteroscedastic F test and Welch's heteroscedastic F test with trimmed means and Winsorized variances. Usage welch.test(formula, data, rate...
/CRAN/refmans/onewaytests/html/welch.test.html
 cran-help  matching: winsorized


Size: 6.2K
R: Penalty parameter for sparse LTS regression
...Use bivariate winsorization to estimate the smallest value of the penalty parameter for sparse least trimmed squares regression that sets all coefficients to zero. Usage lambda0( x, y, normalize...
/CRAN/refmans/robustHD/html/lambda0.html
 cran-help  matching: winsorized


Size: 14.0K
R: Robust Survey Statistics Estimation
...NEWS. Help Pages robsurvey-package Package Overview class_svyreg_rob Utility Functions for Objects of Class svyreg_rob class_svystat_rob Utility Functions for Objects of Class svystat_rob coef.medline...
/CRAN/refmans/robsurvey/html/00Index.html
 cran-help  matching: winsorized


Size: 4.9K
R: Function tweights_bmr
...(dataset, marginal, distance = "klqp", maxit = 1000, tol = 1e-08, warningcut = 0.05, silent = FALSE, Nindependent = 1) Arguments dataset Data frame or matrix to use to find row weights. marginal Must...
/CRAN/refmans/tboot/html/tweights_bmr.html
 cran-help  matching: winsorized


Size: 2.7K
R: colorPicker module server logic
...Provides server logic for the colorPicker2 module. Usage colorPicker( input, output, session, num.colors = 256, distribution = "all", winsorize = NULL, selected = NULL ) Arguments input Shiny's input...
/CRAN/refmans/wilson/html/colorPicker.html
 cran-help  matching: winsorized


Size: 2.2K
R: An S4 class to represent composite ready data
...deviation of each variable standardize A logical value whether standardization was applied distances A data frame of the distance scores distanceDensity A ggplot2 density graph winsorizedValues...
/CRAN/refmans/pscore/html/CompositeReady-class.html
 cran-help  matching: winsorized


Size: 10.7K
R: Paired Data Analysis
...Blink data from Preece (1982, Table 2) Blink2 Blink data (2nd example) from Preece (1982, Table 3) BloodLead Blood lead levels data from Pruzek & Helmreich (2009) bonettseier.Var.test Bonett-Seier...
/CRAN/refmans/PairedData/html/00Index.html
 cran-help  matching: winsorized


Size: 2.3K
R: Collapse graph using PAGA 1.2 algorithm, Wolf et al 2019,...
...1.2 algorithm, Wolf et al 2019, Genome Biology (2019) <https://genomebiology.biomedcentral.com/articles/10.1186/s13059-019-1663-x> Usage collapseGraphPaga(graph, groups, linearize = TRUE, winsorize...
/CRAN/refmans/sccore/html/collapseGraphPaga.html
 cran-help  matching: winsorized


Size: 10.3K
R: (Robust) least angle regression for time series data
...(Robustly) sequence groups of candidate predictors and their respective lagged values according to their predictive content and find the optimal model along the sequence. Note that lagged values of...
/CRAN/refmans/robustHD/html/tslars.html
 cran-help  matching: winsorized


Size: 12.2K
R: Main function to produce a heatmap using PAM clustering.
...more PDFs with the plots. Usage PAM.hm( x, project.folder = ".", nsheets = 1, dec = ".", header = TRUE, symbolcol = 1, sample.names = NULL, cluster.number = 4, trim = NULL, winsorize.mat = TRUE, cols = ...
/CRAN/refmans/PAMhm/html/PAM.hm.html
 cran-help  matching: winsorized


Size: 2.3K
R: GPS locations of three species of whales.
...long logitude location.lat latitude individual.local.identifier identifier for each individual ... Details Irvine LM, Winsor MH, Follett TM, Mate BR, Palacios DM (2020) An at-sea assessment of Argos...
/CRAN/refmans/anipaths/html/whales.html
 cran-help  matching: winsorized


Size: 6.3K
R: Change support of pdqr-function
...elements describing support of the output. Values can be NA, in which case corresponding edge(s) are taken from f's support. method Resupport method. One of "reflect", "trim", "winsor", "linear".
/CRAN/refmans/pdqr/html/form_resupport.html
 cran-help  matching: winsorized


Size: 13.4K
R: Robust least angle regression
...y, sMax = NA, centerFun = median, scaleFun = mad, winsorize = FALSE, const = 2, prob = 0.95, fit = TRUE, s = c(0, sMax), regFun = lmrob, regArgs = list(), crit = c("BIC", "PE"), splits = foldControl(), ...
/CRAN/refmans/robustHD/html/rlars.html
 cran-help  matching: winsorized


Size: 5.5K
R: Bootstrapped correlation coefficients
...sided", "less", "greater", "equivalence", "minimal.effect"), method = c("pearson", "kendall", "spearman", "winsorized", "bendpercent"), alpha = 0.05, null = 0, boot_ci = c("basic", "perc"), R = 1999, ...
/CRAN/refmans/TOSTER/html/boot_cor_test.html
 cran-help  matching: winsorized


Size: 3.9K
R: Tools Inspired by 'Stata' to Manipulate Tabular Data
...statar-package A package for applied research as.monthly Elapsed dates (monthly, quarterly) as.quarterly Elapsed dates (monthly, quarterly) elapsed Elapsed dates (monthly, quarterly) fill_gap Add rows...
/CRAN/refmans/statar/html/00Index.html
 cran-help  matching: winsorized


Size: 4.5K
R: Robust Descriptives
...Descriptives Usage rdesc( data, vars, splitBy = NULL, mean = TRUE, trim = TRUE, tr = 0.2, win = FALSE, wl = 0.2, mest = FALSE, bend = 1.28, med = FALSE ) Arguments data the data as a data frame vars...
/CRAN/refmans/walrus/html/rdesc.html
 cran-help  matching: winsorized


Size: 8.1K
R: Fluctuation Analysis parametric estimation
...mutestim(mc, fn = NULL, mfn = NULL, cvfn = NULL, fitness = NULL, death = 0., plateff = 1., model = c("LD", "H", "I"), muinf = +Inf, method = c("ML", "GF", "P0"), winsor = 2000) Arguments mc a (non-...
/CRAN/refmans/flan/html/mutestim.html
 cran-help  matching: winsorized


Size: 12.3K
R: (Robust) least angle regression for time series data with...
...(Robustly) sequence groups of candidate predictors and their respective lagged values according to their predictive content and find the optimal model along the sequence. Note that lagged values of...
/CRAN/refmans/robustHD/html/tslarsP.html
 cran-help  matching: winsorized


Size: 6.4K
R: Diverse statistics cell function
...Diverse statistics cell function Description Calculating values of several descriptive statistics. Usage stat_cell(x, y, z, w, cell_ids, row_ids, col_ids, vnames, vars, n_min, digits = 3, digits2=1)...
/CRAN/refmans/etable/html/stat_cell.html
 cran-help  matching: winsorized


Size: 13.1K
R: Linear (Lin) Model for Differential Abundance (DA) Analysis...
...and highly scalable approach to tackle the compositional effects in differential abundance analysis of high-dimensional compositional data. It fits linear regression models on the centered log2-ratio...
/CRAN/refmans/MicrobiomeStat/html/linda.html
 cran-help  matching: winsorized


Size: 4.1K
R: Confidence intervals for two-sided tests on correlation...
...correlation coefficient (percentage bend correlation or Winsorized correlation). Usage twopcor(x1, y1, x2, y2, nboot = 599, ...) twocor(x1, y1, x2, y2, corfun = "pbcor", nboot = 599, tr = 0.2, beta...
/CRAN/refmans/WRS2/html/twocor.html
 cran-help  matching: winsorized


Size: 5.9K
R: Weighting for Covariate Balance in Observational Studies
...manually as.weightit.weightit.fit Create a 'weightit' object manually as.weightitMSM Create a 'weightit' object manually as.weightitMSM.default Create a 'weightit' object manually calibrate Calibrate ...
/CRAN/refmans/WeightIt/html/00Index.html
 cran-help  matching: winsorized


Size: 8.3K
R: Computation of Robust Local Covariance Matrices
...generalized local sign covariance matrices for a random field based on a given set of spatial kernel matrices. Usage local_gss_covariance_matrix(x, kernel_list, lcov = c('norm', 'winsor', 'qwinsor')...
/CRAN/refmans/SpatialBSS/html/local_gss_covariance_matrix.html
 cran-help  matching: winsorized


Size: 4.5K
R: Robust correlation coefficients.
...coefficient, wincor the Winsorized correlation, pball the percentage bend correlation matrix, winall the Winsorized correlation matrix. Usage pbcor(x, y = NULL, beta = 0.2, ci = FALSE, nboot = 500...
/CRAN/refmans/WRS2/html/pbcor.html
 cran-help  matching: winsorized


Size: 7.2K
R: Companion to Portfolio Construction and Risk Analysis
...Efficient Frontiers chart.Efront Create Efficient Frontier cleanOutliers Clean Returns Outliers crsp.returns8 crsp.returns8 datFF3W Fama-French Weekly 3-Factor Model datFF4W Fama-French-Carhart Weekly...
/CRAN/refmans/PCRA/html/00Index.html
 cran-help  matching: winsorized


Size: 24.6K
R: Robust Methods for High-Dimensional Data
...NEWS. Help Pages A B C D F G L N P R S T W robustHD-package Robust Methods for High-Dimensional Data -- A -- AIC.seqModel Information criteria for a sequence of regression models AIC.sparseLTS...
/CRAN/refmans/robustHD/html/00Index.html
 cran-help  matching: winsorized


Size: 6.1K
R: compute average run length (ARL) for CUSUM charts
...charts based on the Markov chain algorithm. Usage getARL(distr=NULL, K=NULL, H=NULL, Mean=NULL, std=NULL, prob=NULL, Var=NULL, mu=NULL, lambda=NULL, samp.size=NULL, is.upward=NULL, winsrl=NULL, winsru...
/CRAN/refmans/CUSUMdesign/html/getARL.html
 cran-help  matching: winsorized


Size: 2.3K
R: Summarize Data for Scientific Publication
...Pages apastat Format simple statistic test results for scientific publication correltable Create correlation table (with stars for significance) for scientific publication FullTable1 Create Table1 of...
/CRAN/refmans/scipub/html/00Index.html
 cran-help  matching: winsorized


Size: 3.1K
R: Tools for Binning Data
...rbin_factor Factor binning plot.rbin_manual Manual binning plot.rbin_quantiles Quantile binning plot.rbin_winsorize Winsorized binning rbin 'rbin' package rbinAddin Bin continuous data rbinFactorAddin...
/CRAN/refmans/rbin/html/00Index.html
 cran-help  matching: winsorized


Size: 2.3K
R: Clean outliers
...and is called internally by forecast_univariate, forecast_multivariate, and forecast_combine. Usage data_outliers( Data, variables = NULL, w.bounds = c(0.05, 0.95), trim = FALSE, cross_section = FALSE...
/CRAN/refmans/OOS/html/data_outliers.html
 cran-help  matching: winsorized


Size: 10.1K
R: snap
...to easily design vanilla deep neural networks using 'Tensorflow'/'Keras' backend for regression, classification and multi-label tasks, with some tweaks and tricks (skip shortcuts, embedding, feature...
/CRAN/refmans/snap/html/snap.html
 cran-help  matching: winsorized


Size: 6.8K
R: compute decision interval (H) for CUSUM charts
...for CUSUM charts. Usage getH(distr=NULL, ARL=NULL, ICmean=NULL, ICsd=NULL, OOCmean=NULL, OOCsd=NULL, ICprob=NULL, OOCprob=NULL, ICvar=NULL, IClambda=NULL, samp.size=NULL, ref=NULL, winsrl=NULL, winsru...
/CRAN/refmans/CUSUMdesign/html/getH.html
 cran-help  matching: winsorized


Size: 7.1K
R: The Parameter Estimation Framework of HyperChIP
...ratio factor) by following the framework designed in HyperChIP. Usage estParamHyperChIP( cond, occupy.only = TRUE, prob = 0.1, subset = NULL, p_low = 0.01, p_up = 0.1, return.d0 = FALSE, .call = TRUE, ...
/CRAN/refmans/MAnorm2/html/estParamHyperChIP.html
 cran-help  matching: winsorized


Size: 4.1K
R: Out-of-Sample Time Series Forecasting
Help Pages chart_forecast Chart forecasts chart_forecast_error Chart forecast errors data_impute Impute missing values data_outliers Clean outliers data_reduction Dimension reduction via principal...
/CRAN/refmans/OOS/html/00Index.html
 cran-help  matching: winsorized


Size: 2.9K
R: Robust Re-Scaling to Better Recover Latent Effects in Data
Help Pages asinh Arc-hyperbolic-sine transformation box_cox Traditional box-cox power transformation. Accepts one real parameter box_cox_exp Exponential of the tranditional box-cox transformation...
/CRAN/refmans/rrscale/html/00Index.html
 cran-help  matching: winsorized


Size: 3.1K
R: Robust Nonparametric Two-Sample Tests for Location/Scale
...hl2_test Two-sample location tests based on two-sample Hodges-Lehmann estimator. hodges_lehmann One-sample Hodges-Lehmann estimator hodges_lehmann_2sample Two-sample Hodges-Lehmann estimator med_test...
/CRAN/refmans/robnptests/html/00Index.html
 cran-help  matching: winsorized


Size: 4.7K
R: One-Way Tests for Independent Groups Designs
...onewaytests(formula, data, method = c("aov", "af", "ag", "agp", "ap", "aw", "b2", "bf", "box", "cochran", "gtb", "gtf", "james", "johansen", "kw", "mbf", "pf", "ss", "wa", "welch", "welch_tw", "wgf")...
/CRAN/refmans/onewaytests/html/onewaytests.html
 cran-help  matching: winsorized


Size: 5.0K
R: Tidy Finance Helper Functions
...create_summary_statistics Create Summary Statistics for Specified Variables create_wrds_dummy_database Create WRDS Dummy Database disconnection_connection Disconnect Database Connection download_data ...
/CRAN/refmans/tidyfinance/html/00Index.html
 cran-help  matching: winsorized


Size: 4.9K
R: A Plot Function for Visualizing the ZicoSeq Results
...ZicoSeq.plot produces volcano plots with the y-axis being the log10 (adjusted) p-value and the x-axis being the signed R^2^ with the sign indicating the association direction determined based on the...
/CRAN/refmans/GUniFrac/html/ZicoSeq.plot.html
 cran-help  matching: winsorized


Size: 6.7K
R: p2ViewPagodaApp R6 class
...p2ViewPagodaApp R6 class Description Modified 'PAGODA1' app (from 'SCDE') for browsing 'pagoda2' results. Refer to 'ViewPagodaAppOld' and 'make.pagoda.app()' in 'SCDE' Public fields results Result...
/CRAN/refmans/pagoda2/html/p2ViewPagodaApp.html
 cran-help  matching: winsorized


Size: 5.6K
R: Re-scale a data matrix
...focus further analyses on consequential variance in the data rather than having it be focused on variation resulting from the feature's measurement scale or outliers. Usage rrscale( Y, trans_list...
/CRAN/refmans/rrscale/html/rrscale.html
 cran-help  matching: winsorized


Size: 4.1K
R: Method for heatmap creation
...column.custom.label = NULL, clustering = "none", clustdist = "auto", clustmethod = "auto", colors = NULL, winsorize.colors = NULL, plot.method = "static", width = "auto", height = "auto", ppi = 72...
/CRAN/refmans/wilson/html/create_heatmap.html
 cran-help  matching: winsorized


Size: 7.9K
R: Robust Methods for High-Dimensional Data
...(Khan, Van Aelst & Zamar, 2007; <doi:10.1198/016214507000000950>), (robust) groupwise least angle regression (Alfons, Croux & Gelper, 2016; <doi:10.1016/j.csda.2015.02.007>), and sparse least trimmed ...
/CRAN/refmans/robustHD/html/robustHD-package.html
 cran-help  matching: winsorized


Size: 16.7K
R: Correlation test
..."medium", bayesian_ci_method = "hdi", bayesian_test = c("pd", "rope", "bf"), include_factors = FALSE, partial = FALSE, partial_bayesian = FALSE, multilevel = FALSE, ranktransform = FALSE, winsorize...
/CRAN/refmans/correlation/html/cor_test.html
 cran-help  matching: winsorized


Size: 6.2K
R: Scale a Mean-Variance Curve in a Robust Manner
...curves) in a robust manner. Usage scaleMeanVarCurveRobust( z, m, d0, p_low = 0.01, p_up = 0.1, nw = gauss.quad(128, kind = "legendre") ) Arguments z A list of which each element is a vector of FZ...
/CRAN/refmans/MAnorm2/html/scaleMeanVarCurveRobust.html
 cran-help  matching: winsorized


Size: 7.5K
R: Transform Univariate Time Series
...series demedian Removes measure of centrality from the series demode Removes measure of centrality from the series diffx Compute lagged differnces diffx-rdiffx-ldiffx Compute lagged differnces dtrend...
/CRAN/refmans/transx/html/00Index.html
 cran-help  matching: winsorized


Size: 3.2K
R: Estimating the regression coefficients in NPNGMs with lasso
...regression coefficents in NPNGMs for constructing the test statistic. The regression is based on a truncated (Winsorized) estimator for the transformation functions in NPNGMs. Usage lassoNPN(Data_mat)...
/CRAN/refmans/DNetFinder/html/lassoNPN.html
 cran-help  matching: winsorized


Size: 5.5K
R: MI-aware Modifed eBayes Function
...eBayes.mod( fit, VarRubin, proportion = 0.01, stdev.coef.lim = c(0.1, 4), trend = FALSE, robust = FALSE, winsor.tail.p = c(0.05, 0.1) ) Arguments fit an MArrayLM fitted model object produced by lmFit...
/CRAN/refmans/mi4p/html/eBayes.mod.html
 cran-help  matching: winsorized


Size: 5.6K
R: MI-aware Modifed eBayes Function
...limma package Usage hid.ebayes( fit, VarRubin, mod = TRUE, proportion = 0.01, stdev.coef.lim = c(0.1, 4), trend = FALSE, robust = FALSE, winsor.tail.p = c(0.05, 0.1) ) Arguments fit an MArrayLM fitted...
/CRAN/refmans/mi4p/html/hid.ebayes.html
 cran-help  matching: winsorized


Size: 4.0K
R: An constructor function for the S4 CompositeReady class
...class Usage CompositeReady( data, covmat, sigma, standardize, use.prethreshold, distances, distanceDensity, winsorizedValues, better, rawdata, groups, thresholds, higherisbetter, k, rawtrans...
/CRAN/refmans/pscore/html/CompositeReady.html
 cran-help  matching: winsorized


Size: 3.8K
R: Forecast with forecast combinations
...(winsorized) mean, n-best, ridge regression, lasso regression, elastic net, peLASSO, random forest, tree-based gradient boosting machine, and single-layer neural network. See package website for most...
/CRAN/refmans/OOS/html/forecast_combine.html
 cran-help  matching: winsorized


Size: 4.6K
R: Comparing Correlations between independent studies with...
boot_compare_cor {TOSTER} R Documentation Comparing Correlations between independent studies with bootstrapping Description A function to compare standardized mean differences (SMDs) between studies.
/CRAN/refmans/TOSTER/html/boot_compare_cor.html
 cran-help  matching: winsorized




powered by xapian
hosted and maintained by the Institute for Statistics and Mathematics
of WU (Vienna University of Economics and Business)
give a feedback