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 710 matches
Term frequencies: ecdf: 715
Search took 0.003287 seconds

Size: 1.4K
R: Modified ECDF function
DHARMa.ecdf {DHARMa} R Documentation Modified ECDF function Description Modified ECDF function Usage DHARMa.ecdf(x) Details ensures symmetric ECDF (standard ECDF is <), and that 0 / 1 values are only...
/CRAN/refmans/DHARMa/html/DHARMa.ecdf.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 2.0K
R: Converts this histogram to an instance of the "ecdf" class,...
...Converts this histogram to an instance of the "ecdf" class, allowing the calculation of cumulative densities, and quantiles Usage ## S4 method for signature 'HistDat' as.ecdf(x) Arguments x An...
/CRAN/refmans/HistDat/html/as.ecdf-HistDat-method.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 1.9K
R: Plot ecdf
...ecdf Description Plot ecdf for U-Pb age or Lu-Hf model age data. Usage plot_ecdf( dat, mult_ecdf = FALSE, column = "age", conf = FALSE, guide = TRUE, alpha = 0.05 ) Arguments dat data.frame mult_ecdf...
/CRAN/refmans/detzrcr/html/plot_ecdf.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 2.1K
R: Produce the posterior distribution ECDF panel for the TS...
...ECDF panel for the TS diagnostic plot of a parameter Description Produce a vanilla ECDF (empirical cumulative distribution function) plot using ecdf for the parameter of interest (rho or eta) as part...
/CRAN/refmans/LDATS/html/ecdf_plot.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 2.2K
R: Radarplot of the area under the aggregated ECDF-curve of a...
...aggregated ECDF-curve of a DataSetList. Description Radarplot of the area under the aggregated ECDF-curve of a DataSetList. Usage Plot.FV.ECDF_AUC(dsList, rt_min = NULL, rt_max = NULL, rt_step = NULL)...
/CRAN/refmans/IOHanalyzer/html/Plot.FV.ECDF_AUC.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 3.1K
R: nos.ecdf text-based plot of an empirical CDF.
...ecdf {NostalgiR} R Documentation nos.ecdf text-based plot of an empirical CDF. Description Plots a text-based empirical cumulative distribution function. Usage nos.ecdf(data, xlab = NULL, ratio = 0.25...
/CRAN/refmans/NostalgiR/html/nos.ecdf.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 2.4K
R: Radarplot of the area under the aggregated ECDF-curve of a...
...under the aggregated ECDF-curve of a DataSetList. Description Radarplot of the area under the aggregated ECDF-curve of a DataSetList. Usage Plot.RT.ECDF_AUC( dsList, fstart = NULL, fstop = NULL, fstep...
/CRAN/refmans/IOHanalyzer/html/Plot.RT.ECDF_AUC.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 1.9K
R: Generation of default ECDF-targets
get_ECDF_targets {IOHanalyzer} R Documentation Generation of default ECDF-targets Description Generation of default ECDF-targets Usage get_ECDF_targets(dsList, type = "log-linear", number_targets = 10)...
/CRAN/refmans/IOHanalyzer/html/get_ECDF_targets.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 1.7K
R: Generate ECDF targets for a DataSetList
...Generate ECDF targets for a DataSetList Description Generate ECDF targets for a DataSetList Usage get_default_ECDF_targets(data, format_func = as.integer) Arguments data A DataSetList format_func...
/CRAN/refmans/IOHanalyzer/html/get_default_ECDF_targets.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 2.2K
R: plot difference ecdfs
...ecdfs Description This function computes the values of the cumulative difference of two empirical cumulative distribution function and plots the values. Usage dif_ecdf_plot(data_1, data_2, bins_size)...
/CRAN/refmans/stodom/html/dif_ecdf_plot.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 2.0K
R: plot ecdfs
...ecdfs Description This function computes the values of two empirical cumulative distribution function and plots the values. Usage ecdf_plot(data_1, data_2, bins_size) Arguments data_1 data 1. data_2...
/CRAN/refmans/stodom/html/ecdf_plot.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 1.6K
R: Compute ECDF (empirical cumulative distribution function)
compute_ecdf {dupiR} R Documentation Compute ECDF (empirical cumulative distribution function) Description Compute ECDF (empirical cumulative distribution function) Usage compute_ecdf(posterior)...
/CRAN/refmans/dupiR/html/compute_ecdf.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 2.1K
R: values of two ecdf and their cumulative difference
...ecdf and their cumulative difference Description This function computes the values of two empirical cumulative distribution function as well as their cumulative differences. Usage ecdf_dat_g(data_1...
/CRAN/refmans/stodom/html/ecdf_dat_g.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 4.0K
R: Create an ECDF overlaid with a Normal CDF
...Create an ECDF overlaid with a Normal CDF Description Creates an emperical cumulative distribution function (ECDF) overlaid with a cumulative distribution function (CDF) Usage chart.ECDF( R, main...
/CRAN/refmans/PerformanceAnalytics/html/chart.ECDF.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 2.4K
R: Generate dataframe consisting of the ECDF-equivalent based on...
...of the ECDF-equivalent based on the EAF Description This function uses EAF-data to calculate a target-independent version of the ECDF Usage generate_data.ECDF_From_EAF( eaf_table, min_val, max_val...
/CRAN/refmans/IOHanalyzer/html/generate_data.ECDF_From_EAF.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 3.2K
R: Test for differences in log2(Fold Change) ECDFs between two...
...in log2(Fold Change) ECDFs between two gene lists using the stats package Description This function uses the stats package to test the ECDF of log2(Fold Changes) between two groups based on DESeq2...
/CRAN/refmans/SeedMatchR/html/ecdf_stat_test.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 5.1K
R: Plot the ECDF for DESeq2 log2(Fold Changes)
deseq_fc_ecdf {SeedMatchR} R Documentation Plot the ECDF for DESeq2 log2(Fold Changes) Description This functions will take DESeq2 results as a data.frame and plot the ecdf for the input gene.lists.
/CRAN/refmans/SeedMatchR/html/deseq_fc_ecdf.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 5.2K
R: Plots and checks for distributions - only, but with ecdf
...and checks for distributions – only, but with ecdf Description Data quality indicator checks "Unexpected location" and "Unexpected proportion" with histograms and, if a grouping variable is included...
/CRAN/refmans/dataquieR/html/acc_distributions_only_ecdf.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 5.8K
R: Plots and checks for distributions - Location, ECDF
...checks for distributions – Location, ECDF Description Data quality indicator checks "Unexpected location" and "Unexpected proportion" with histograms and, if a grouping variable is included, plots...
/CRAN/refmans/dataquieR/html/acc_distributions_loc_ecdf.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 12.8K
R: Plot ECDF for the predicted probabilities
plot_probabilities_ecdf {cvms} R Documentation Plot ECDF for the predicted probabilities Description Plots the empirical cumulative distribution function (ECDF) for the probabilities of either...
/CRAN/refmans/cvms/html/plot_probabilities_ecdf.html
 cran-help  matching: ecdf, ecdf and ecdf


Size: 2.8K
R: Consensus Matrix ECDFs
...Consensus Matrix ECDFs Description consensusECDF plots the empirical cumulative distribution functions (ECDF) of the consensus matrices produced during the consensus clustering step of the neatmap...
/CRAN/refmans/neatmaps/html/consensusECDF.html
 cran-help  matching: ecdf and ecdf


Size: 4.3K
R: Plot Binned Histogram and ECDF Data.
...Plot Binned Histogram and ECDF Data. Description Produces aesthetically pleasing ECDF plots for two common classes of non-equiwidth histograms. Specifically, (1) histograms with power of two bucket...
/CRAN/refmans/HistogramTools/html/plot.html
 cran-help  matching: ecdf and ecdf


Size: 2.6K
R: Change in Area Under the ECDF
...(neatmap_res) Arguments neatmap_res Output from the neatmap function. Value A ggplot of the change in consecutive area under the ECDFs of the consensus cluster matrices. Author(s) Philippe Boileau, ...
/CRAN/refmans/neatmaps/html/consensusChangeECDF.html
 cran-help  matching: ecdf and ecdf


Size: 2.5K
R: Weighted empirical cumulative distribution function (ecdf),...
...(ecdf), conditional on one or more variables Description Weighted empirical cumulative distribution function (ecdf), conditional on one or more variables Usage Fhat_conditional_(.data, .variables, x...
/CRAN/refmans/distrr/html/Fhat_conditional_.html
 cran-help  matching: ecdf and ecdf


Size: 1.4K
R: Invert Ecdf
invertEcdf {BMisc} R Documentation Invert Ecdf Description take an ecdf object and invert it to get a step-quantile function Usage invertEcdf(df) Arguments df an ecdf object Value stepfun object that...
/CRAN/refmans/BMisc/html/invertEcdf.html
 cran-help  matching: ecdf and ecdf


Size: 1.7K
R: Sample From an ECDF
...(ECDF) sampler. Usage recdf(x, n) Arguments x numeric vector n number of draws Value vector of n elements of the same type as x See Also ecdf Examples recdf(1:5, 10) [Package litteR version 1.0.0...
/CRAN/refmans/litteR/html/recdf.html
 cran-help  matching: ecdf and ecdf


Size: 2.0K
R: Draws random values from the ECDF obtained from 'sample'
...to base the ECDF on Value numeric vector of random values drawn from the ECDF References Chakraborti, S., Hong, B., & Van De Wiel, M. A. (2006). A note on sample size determination for a nonparametric...
/CRAN/refmans/skewsamp/html/remp.html
 cran-help  matching: ecdf and ecdf


Size: 4.2K
R: Exact stochastic dominance computation from areas above ECDF...
exactSdMtx {generalCorr} R Documentation Exact stochastic dominance computation from areas above ECDF pillars. Description ECDF=empirical cumulative distribution functions. These are sufficient...
/CRAN/refmans/generalCorr/html/exactSdMtx.html
 cran-help  matching: ecdf and ecdf


Size: 2.7K
R: Generate dataframe containing the AUC for any ECDF-curves
...ECDF-curves Description This function generates a dataframe which can be easily plotted using the 'plot_general_data'-function Usage generate_data.AUC( dsList, targets, scale_log = F, which = "by_RT"...
/CRAN/refmans/IOHanalyzer/html/generate_data.AUC.html
 cran-help  matching: ecdf and ecdf


Size: 2.1K
R: Empirical cumulative density function (ECDF)
...a sample of observations, as used by described by Chakraborti (2006). Usage pemp(q, sample) Arguments q numeric vector of values to evaluate sample numeric vector of sample values to base the ECDF on...
/CRAN/refmans/skewsamp/html/pemp.html
 cran-help  matching: ecdf and ecdf


Size: 3.6K
R: Swap axis of ecdf plot and reverse y axis
rotecdf {spreval} R Documentation Swap axis of ecdf plot and reverse y axis Description plots points generated from an 'stats::ecdf' object with x and y axis swapped (x is cumulative frequency)...
/CRAN/refmans/spreval/html/rotecdf.html
 cran-help  matching: ecdf and ecdf


Size: 2.3K
R: Transpose of ECDF for centered fitted values and residuals...
diagplot5new {HH} R Documentation Transpose of ECDF for centered fitted values and residuals from a linear model. Description Transpose of ECDF (Empirical CDF) for centered fitted values and residuals...
/CRAN/refmans/HH/html/diagplot5new.html
 cran-help  matching: ecdf and ecdf


Size: 5.9K
R: Compute an ECDF for Censored Data
...an ECDF for Censored Data Description Computes an estimate of an empirical cumulative distribution function (ECDF) for censored data using the Kaplan-Meier method. Usage cenfit(obs, censored, groups...
/CRAN/refmans/NADA/html/cenfit.html
 cran-help  matching: ecdf and ecdf


Size: 4.1K
R: Plot the ECDF of a uniform sample with Kolmogorov-Smirnov...
...(ecdf), and adds a confidence band by inverting the corresponding Kolmogorov-Smirnov test (ks.test). The uniform distribution is rejected if the ECDF is not completely inside the confidence band.
/CRAN/refmans/surveillance/html/ks.plot.unif.html
 cran-help  matching: ecdf and ecdf


Size: 4.6K
R: ECDF plot of a given quantile of a variable calculated by...
...ECDF plot of a given quantile of a variable calculated by group Description Plots a given quantile of a variable calculated by group as an ECDF plot with points sized by the numbers of items per group.
/CRAN/refmans/DRomics/html/ecdfquantileplot.html
 cran-help  matching: ecdf and ecdf


Size: 7.4K
R: Compute an ECDF and Distribution Parameters for Censored Data
cfit {NADA2} R Documentation Compute an ECDF and Distribution Parameters for Censored Data Description Computes the empirical cumulative distribution function (ECDF) for censored data. Estimates...
/CRAN/refmans/NADA2/html/cfit.html
 cran-help  matching: ecdf and ecdf


Size: 8.2K
R: ECDF plot of a variable with given confidence intervals on...
ecdfplotwithCI {DRomics} R Documentation ECDF plot of a variable with given confidence intervals on this variable Description Provides an ECDF plot of a variable, with x-error bars for given confidence...
/CRAN/refmans/DRomics/html/ecdfplotwithCI.html
 cran-help  matching: ecdf and ecdf


Size: 2.4K
R: Generate dataframe of a single function/dimension pair
...This function generates a dataframe which can be easily plotted using the 'plot_general_data'-function Usage generate_data.ECDF( dsList, targets, scale_log = F, which = "by_RT", use_full_range = TRUE...
/CRAN/refmans/IOHanalyzer/html/generate_data.ECDF.html
 cran-help  matching: ecdf and ecdf


Size: 6.2K
R: Detrended Transformed Owen's Plot and ECDF for the residuals
...Detrended Transformed Owen's Plot and ECDF for the residuals Description The function resid_dtop() provides single de-trended transformed Owen's plot, Owen (1995), for a GAMLSS fitted objects or any...
/CRAN/refmans/gamlss.ggplots/html/resid_dtop.html
 cran-help  matching: ecdf and ecdf


Size: 5.0K
R: Test Censored ECDF Differences
cendiff {NADA} R Documentation Test Censored ECDF Differences Description Tests if there is a difference between two or more empirical cumulative distribution functions (ECDF) using the G^\rho family...
/CRAN/refmans/NADA/html/cendiff.html
 cran-help  matching: ecdf and ecdf


Size: 3.1K
R: Plot the ECDF of p-values from resampling
plotPvals {modnets} R Documentation Plot the ECDF of p-values from resampling Description Plots the empirical cumulative distribution function of the p-values related to iterated resampling via...
/CRAN/refmans/modnets/html/plotPvals.html
 cran-help  matching: ecdf and ecdf


Size: 2.0K
R: Obtaining the inverse of marginal empirical cumulative...
...Obtaining the inverse of marginal empirical cumulative distribution (ECDF) Description Obtaining the inverse of marginal empirical cumulative distribution (ECDF) Usage ecdf.inv(x, p, sort.flag = TRUE)...
/CRAN/refmans/copulaSim/html/ecdf.inv.html
 cran-help  matching: ecdf and ecdf


Size: 2.0K
R: Empirical Cumulative Dsitribution Function of Runtime of a...
...Dsitribution Function of Runtime of a single data set Usage ECDF(ds, ftarget, ...) ## S3 method for class 'DataSet' ECDF(ds, ftarget, ...) ## S3 method for class 'DataSetList' ECDF(ds, ftarget...
/CRAN/refmans/IOHanalyzer/html/ECDF.html
 cran-help  matching: ecdf and ecdf


Size: 1.7K
R: Converts an object to an empirical cumulative density...
Usage as.ecdf(x) Arguments x The object to coerce to a eCDF Value An instance of the "ecdf" class See Also ecdf() Examples cdf <- as.ecdf(1:4) cdf(2) # returns 0.5 [Package HistDat version 0.2.0...
/CRAN/refmans/HistDat/html/as.ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 2.8K
R: Plot Empirical Distribution Function With 95% Confidence...
...(ECDF) for univariate data, together with upper and lower simultaneous 95% confidence curves, computed via Kolmogorov-Smirnov' D, see KSd. Usage ecdf.ksCI(x, main = NULL, sub = NULL, xlab = deparse...
/CRAN/refmans/sfsmisc/html/ecdf.ksCI.html
 cran-help  matching: ecdf and ecdf


Size: 1.4K
R: Empirical cummulative distrubution function
ECDF {CoSMoS} R Documentation Empirical cummulative distrubution function Description Calculates ecdf based on weibull plotting position Usage ECDF(x) Arguments x vector of values Examples ECDF(round...
/CRAN/refmans/CoSMoS/html/ECDF.html
 cran-help  matching: ecdf and ecdf


Size: 10.7K
R: Utilities for projected-ecdf statistics of spherical...
Pn {sphunif} R Documentation Utilities for projected-ecdf statistics of spherical uniformity Description Computation of the kernels \psi_p^W(\theta) := \int_{-1}^1 A_x(\theta)\,\mathrm{d}W(F_p(x))...
/CRAN/refmans/sphunif/html/Pn.html
 cran-help  matching: ecdf and ecdf


Size: 2.7K
R: Kolmogorov's Confidence Band
.../2003-July/036643.html Usage ecdf.ks.CI(x, main = NULL, sub = NULL, xlab = deparse(substitute(x)), ...) Arguments x a vector of data of length n main the title of the plot. The default is ecdf(x) + 95%...
/CRAN/refmans/NSM3/html/ecdf.ks.CI.html
 cran-help  matching: ecdf and ecdf


Size: 1.7K
R: Return empirical CDF for model outcome variables
ecdf.outcomes {pspline.inference} R Documentation Return empirical CDF for model outcome variables Description Return empirical CDF for model outcome variables Usage ecdf.outcomes(data, model)...
/CRAN/refmans/pspline.inference/html/ecdf.outcomes.html
 cran-help  matching: ecdf and ecdf


Size: 2.9K
R: The empirical cumulative distribution function plot
ecdf.betaclust {betaclust} R Documentation The empirical cumulative distribution function plot Description An empirical cumulative distribution function (ECDF) plot for a betaclust object. Usage ecdf...
/CRAN/refmans/betaclust/html/ecdf.betaclust.html
 cran-help  matching: ecdf and ecdf


Size: 4.6K
R: Empirical Distribution Function and Quantiles
...inference is not conducted for this method. Usage BIFIE.ecdf( BIFIEobj, vars, breaks=NULL, quanttype=1, group=NULL, group_values=NULL ) ## S3 method for class 'BIFIE.ecdf' summary(object,digits=4...
/CRAN/refmans/BIFIEsurvey/html/BIFIE.ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 3.1K
R: Empirical Cumulative Distribution Function
eCDF {VGAM} R Documentation Empirical Cumulative Distribution Function Description Returns the desired quantiles of quantile regression object such as an extlogF1() or lms.bcn() VGLM object Usage eCDF...
/CRAN/refmans/VGAM/html/eCDF.html
 cran-help  matching: ecdf and ecdf


Size: 3.2K
R: Censored Empirical Cumulative Distribution Function
...Plots ecdfs of one or more groups of censored data. Illustrates the differences between groups for group tests such as those done using cen1way or cenanova. Usage cen_ecdf( x.var, cens.var, xgroup...
/CRAN/refmans/NADA2/html/cen_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 2.9K
R: Efficient evaluation of the empirical cumulative distribution...
...distribution function (ecdf) of a sample data at the evaluation points sorted_x. This is done through binary search. Usage ecdf_bin(data, sorted_x, data_sorted = FALSE, efic = TRUE, divide_n = TRUE)...
/CRAN/refmans/sphunif/html/ecdf_bin.html
 cran-help  matching: ecdf and ecdf


Size: 2.1K
R: Get the marginal contribution of an algorithm to a portfolio
...to the ECDF-curve of the VBS of the portfolio Usage get_marg_contrib_ecdf(id, perm, j, dt) Arguments id The id for which to get the contribution perm The permutation of algorithms to which is being...
/CRAN/refmans/IOHanalyzer/html/get_marg_contrib_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 3.6K
R: Weighted empirical cumulative distribution function
weighted_ecdf {ggdist} R Documentation Weighted empirical cumulative distribution function Description A variation of ecdf() that can be applied to weighted samples. Usage weighted_ecdf(x, weights...
/CRAN/refmans/ggdist/html/weighted_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 2.3K
R: Pairs empirical cummulative distribution functions for all...
...cummulative distribution functions for all groups supplied by the formula. Usage paired_ecdf(data, formula, cuts = NULL) Arguments data The data frame used for estimation - ideally structured...
/CRAN/refmans/esvis/html/paired_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 2.3K
R: Computes the empirical cummulative distribution function for...
...cummulative distribution function for all groups supplied by the formula. Usage ecdf_fun(data, formula, cuts = NULL) Arguments data The data frame used for estimation - ideally structured in a tidy...
/CRAN/refmans/esvis/html/ecdf_fun.html
 cran-help  matching: ecdf and ecdf


Size: 6.8K
R: Empirical Cumulative Distribution Function
...“ecdf” object. Usage ecdf(x) ## S3 method for class 'ecdf' plot(x, ..., ylab="Fn(x)", verticals = FALSE, col.01line = "gray70", pch = 19) ## S3 method for class 'ecdf' print(x, digits= getOption...
/R/refmans/stats/html/ecdf.html
 r-help  matching: ecdf and ecdf


Size: 2.3K
R: RUV P-value Empirical CDF Plot
ruv_ecdf {ruv} R Documentation RUV P-value Empirical CDF Plot Description Plots an ECDF of p-values returned by a call to ruv_summary Usage ruv_ecdf(fit, X.col = "all", power = 1, uniform.lines = 0)...
/CRAN/refmans/ruv/html/ruv_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 2.0K
R: Generate dataframe of a the unaggregated values of individual...
...of individual algorithms. Stripped-down version of Description This provides an unaggregated version of the function 'generate_data.ECDF'. Usage generate_data.ECDF_raw(dsList, targets, scale_log = F)...
/CRAN/refmans/IOHanalyzer/html/generate_data.ECDF_raw.html
 cran-help  matching: ecdf and ecdf


Size: 6.4K
R: Compute empirical cumulative distribution
...(ECDF) provides an alternative visualisation of distribution. Compared to other visualisations that rely on density (like geom_histogram()), the ECDF doesn't require any tuning parameters and handles...
/CRAN/refmans/ggplot2/html/stat_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 6.5K
R: Formula interace to empirical cumulative distribution
...(ECDF) provides an alternative visualization of distribution. Compared to other visualizations that rely on density (like histograms or density plots) the ECDF doesn't require any tuning parameters...
/CRAN/refmans/ggformula/html/gf_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 13.4K
R: Empirical Cumulative Distribution Plot
Ecdf {Hmisc} R Documentation Empirical Cumulative Distribution Plot Description Computes coordinates of cumulative distribution function of x, and by defaults plots it as a step function. A grouping...
/CRAN/refmans/Hmisc/html/Ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 2.7K
R: Plot the aggregated empirical cumulative distriburtion as a...
...distriburtion as a function of the running times of a DataSetList. Usage Plot.RT.ECDF_Single_Func( dsList, fstart = NULL, fstop = NULL, fstep = NULL, show.per_target = F, scale.xlog = F ) ## S3 method...
/CRAN/refmans/IOHanalyzer/html/Plot.RT.ECDF_Single_Func.html
 cran-help  matching: ecdf and ecdf


Size: 2.7K
R: Empirical estimate of the CDF
...method for class 'rkt_ecdf' variance(x, ...) ## S3 method for class 'rkt_ecdf' plot(x, ...) Arguments x Numeric vector containing the sample. Alternatively, if w is supplied, distinct values within ...
/CRAN/refmans/ROCket/html/rkt_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 5.5K
R: Calculate weighted and unweighted empirical cumulative...
...distribution function (ECDF) provides an alternative visualization of distribution. geom_ecdf() is similar to ggplot2::stat_ecdf() but it can also calculate weighted ECDFs. Usage geom_ecdf( mapping...
/CRAN/refmans/halfmoon/html/geom_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 2.9K
R: Plot the aggregated empirical cumulative distriburtion as a...
...distriburtion as a function of the function values of a DataSetList. Usage Plot.FV.ECDF_Single_Func( dsList, rt_min = NULL, rt_max = NULL, rt_step = NULL, scale.xlog = F, show.per_target = F, scale...
/CRAN/refmans/IOHanalyzer/html/Plot.FV.ECDF_Single_Func.html
 cran-help  matching: ecdf and ecdf


Size: 5.7K
R: Plot empirical cumulative distribution functions of...
...functions (ECDFs) of numerical performance metrics across multiple simulations from a "trial_results" object returned by run_trials(). Requires the ggplot2 package installed. Usage plot_metrics_ecdf...
/CRAN/refmans/adaptr/html/plot_metrics_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 4.6K
R: Empirical Cumulative Distribution Plot
...scale. Usage ecdf_plot( data, formula, cuts = NULL, linewidth = 1.2, ref_line_cols = "gray40", ref_linetype = "solid", center = FALSE, ref_rect = TRUE, ref_rect_col = "gray40", ref_rect_alpha = 0.15...
/CRAN/refmans/esvis/html/ecdf_plot.html
 cran-help  matching: ecdf and ecdf


Size: 4.7K
R: Empirical Cumulative Density Function
...of aesthetic mappings created by aes or aes_. If specified and inherit.aes = TRUE (the default), it is combined with the default mapping at the top level of the plot. You must supply mapping if there ...
/CRAN/refmans/animint2/html/stat_ecdf.html
 cran-help  matching: ecdf and ecdf


Size: 3.3K
R: Empirical Cumulative Distribution Function with Exponential...
...distribution funciton (ecdf) of a given vector of observations, and approximates the tails of the ecdf with exponential curves. Usage exptailecdf(x, N = max(2, 0.002 * length(x)), m = min(N, 5))...
/CRAN/refmans/spc4sts/html/exptailecdf.html
 cran-help  matching: ecdf


Size: 6.3K
R: TaxaNorm Results
...store TaxaNorm Results Usage TaxaNorm_Results( input_data, rawdata, normdata, ecdf, model_pars, converge, llk, final_df ) ## S4 method for signature 'TaxaNorm_Results' input_data(x) ## S4 replacement...
/CRAN/refmans/TaxaNorm/html/TaxaNorm_Results-class.html
 cran-help  matching: ecdf


Size: 3.3K
R: Pairwise Measures for Two Sets of Empirical CDFs
...(ECDF). For simplicity, we only take an input of ecdf objects from stats package. Usage ecdfdist2(elist1, elist2, method = c("KS", "Lp", "Wasserstein"), p = 2) Arguments elist1 a length M list of ecdf...
/CRAN/refmans/maotai/html/ecdfdist2.html
 cran-help  matching: ecdf


Size: 3.7K
R: Wasserstein Median of Empirical CDFs
...obtained by a functional variant of the Weiszfeld algorithm on a set of quantile functions. Usage ecdfmed(ecdfs, weights = NULL, ...) Arguments ecdfs a length-N list of "ecdf" objects by stats::ecdf().
/CRAN/refmans/T4transport/html/ecdfmed.html
 cran-help  matching: ecdf


Size: 3.3K
R: Barycenter of Empirical CDFs
This is obtained by taking a weighted average on a set of corresponding quantile functions. Usage ecdfbary(ecdfs, weights = NULL, ...) Arguments ecdfs a length-N list of "ecdf" objects by stats::ecdf().
/CRAN/refmans/T4transport/html/ecdfbary.html
 cran-help  matching: ecdf


Size: 3.7K
R: Grenander Estimator of a Decreasing or Increasing Density
...grenander computes the Grenander estimator of a one-dimensional decreasing or increasing density. Usage grenander(F, type=c("decreasing", "increasing")) Arguments F an ecdf containing the empirical...
/CRAN/refmans/fdrtool/html/grenander.html
 cran-help  matching: ecdf


Size: 11.0K
R: Frequency Distribution Plot
...function (ecdf) in one single plot. A rug as well as a model distribution curve (e.g. a normal curve) can optionally be superposed. This results in a dense and informative picture of the facts. Still...
/CRAN/refmans/DescTools/html/PlotFdist.html
 cran-help  matching: ecdf


Size: 1.9K
R: Area Under Curve (Empirical Cumulative Dsitribution Function)
...fun A ECDF object. from double. Starting point of the area on x-axis to double. Ending point of the area on x-axis Value a object of type 'ECDF' Examples ecdf <- ECDF(dsl,c(12,14)) AUC(ecdf, 0, 100)...
/CRAN/refmans/IOHanalyzer/html/AUC.html
 cran-help  matching: ecdf


Size: 3.8K
R: Empirical Cumulative Distribution Function
...function (ecdf). The function offers the option to construct the ecdf on the base of a histogram, which makes sense, when x is large. So the plot process is much faster, without loosing much precision...
/CRAN/refmans/DescTools/html/PlotECDF.html
 cran-help  matching: ecdf


Size: 5.2K
R: Discrete Cramer-von Mises Goodness-of-Fit Tests
...FALSE, B=2000, tol=1e-8) Arguments x a numerical vector of data values. y an ecdf or step-function (stepfun) for specifying the hypothesized model. type the variant of the Cramer-von Mises test; "W2"...
/CRAN/refmans/dgof/html/cvm.test.html
 cran-help  matching: ecdf


Size: 2.6K
R: ecdfSteps
...or leave it missing to extend it 1/20th of the observed range on other side. Details For a numeric vector uses the R built-in ecdf function to compute coordinates of the ECDF, with extension slightly...
/CRAN/refmans/Hmisc/html/ecdfSteps.html
 cran-help  matching: ecdf


Size: 3.0K
R: Distance Measures between Multiple Empirical Cumulative...
...functions (ECDF). For simplicity, we only take an input of ecdf objects from stats package. Usage ecdfdist(elist, method = c("KS", "Lp", "Wasserstein"), p = 2, as.dist = FALSE) Arguments elist a...
/CRAN/refmans/maotai/html/ecdfdist.html
 cran-help  matching: ecdf


Size: 2.2K
R: Algorithms for Visual Analogue Scales
...bands. Value Estimate of the emprical distribution function. x grid points y ECDF value Fn(x) lb, ub lower and upper confidence bands of ECDF. alpha significance level data raw data ecdf Draw ECDF if...
/CRAN/refmans/bda/html/VAS.html
 cran-help  matching: ecdf


Size: 2.1K
R: Calculate cumulative density
...extends the functionality of of the standard implementation of ECDF. Sometimes it is desireable to get the ECDF from pre-tabulated values. For this, elements in x and y have to be linked to each other.
/CRAN/refmans/fitteR/html/ecdf2.html
 cran-help  matching: ecdf


Size: 3.6K
R: Plot distributions
...(ECDF) plots. The latter give more information, yet not all audiences are familiar with them. Usage plot_distributions( distributions, plot_type = c("auto", "histogram", "ecdf", "density"), max_plots...
/CRAN/refmans/rsprite2/html/plot_distributions.html
 cran-help  matching: ecdf


Size: 4.5K
R: Display Kaplan-Meier empirical cumulative distribution...
...Kaplan-Meier (KM) method and a cubic smoothing spline fitted to it (KMSS method, see multKM). Usage splineKM(x, label = NULL, dl = NULL, n.knots = NULL, legend.pos = "bottomright", ylab = "ECDF", xlab...
/CRAN/refmans/zCompositions/html/splineKM.html
 cran-help  matching: ecdf


Size: 4.0K
R: Compute percentiles of area receiving less than and greater...
...more application than the target depth, assuming catch cans represent approximately equal areas. It also a measure of adequacy and efficiency determined from areas of a density curve receiving amounts...
/CRAN/refmans/spreval/html/adper.html
 cran-help  matching: ecdf


Size: 3.9K
R: Mean of Empirical Cumulative Distribution Function
...class 'ecdf' mean(x, trim=0, ...) ## S3 method for class 'ewcdf' mean(x, trim=0, ...) Arguments x An empirical cumulative distribution function (object of class "ecdf" created by ecdf) or a weighted...
/CRAN/refmans/spatstat.geom/html/mean.ewcdf.html
 cran-help  matching: ecdf


Size: 5.2K
R: Plot a transformed empirical cdf
...Produces a basic plot showing a transformed empirical cdf for heavy tailed data. It uses a log-log transform on the tails, which shows power law decay as linear. Usage ecdfHT(x, scale.q = c(0.25, 0.5...
/CRAN/refmans/ecdfHT/html/ecdfHT.html
 cran-help  matching: ecdf


Size: 16.3K
R: Empirical Cumulative Distribution Function Plot
...ifelse(discrete, "emp.probs", "plot.pos"), plot.pos.con = 0.375, plot.it = TRUE, add = FALSE, ecdf.col = "black", ecdf.lwd = 3 * par("cex"), ecdf.lty = 1, curve.fill = FALSE, curve.fill.col = "cyan"...
/CRAN/refmans/EnvStats/html/ecdfPlot.html
 cran-help  matching: ecdf


Size: 5.7K
R: Compute distribution weights from GOF
...weight1 for all dists, weight2 places zero weight on the worst fitting function, weight3 on the worst half of functions. Usage distLweights( RMSE, order = TRUE, onlydn = TRUE, weightc = NA, quiet...
/CRAN/refmans/extremeStat/html/distLweights.html
 cran-help  matching: ecdf


Size: 3.9K
R: Plot method for 'chemSigSelect'
...'chemSigSelect' plot( x, paramList = NULL, type = c("boxplot", "ecdf", "density"), logAxes = TRUE, ... ) Arguments x chemSigSelect class object paramList character vector of column names of chemical...
/CRAN/refmans/RFPM/html/plot.chemSigSelect.html
 cran-help  matching: ecdf


Size: 4.5K
R: Weighted Empirical Cumulative Distribution Function
...vector of non-negative weights for x. Defaults to equal weight 1 for each entry of x. normalise Logical value indicating whether the weights should be rescaled so that they sum to 1. adjust Numeric...
/CRAN/refmans/spatstat.geom/html/ewcdf.html
 cran-help  matching: ecdf


Size: 1.9K
R: Empirical Cumulative Distribution Function with Exponential...
...by exptailecdf. Value ecdf the ecdf returned by the stats::ecdf() lambda the parameters estimated for the exponential curves. lambda[1] corresponds to the left tail. joint where the ecdf started to be...
/CRAN/refmans/spc4sts/html/exptailecdf.object.html
 cran-help  matching: ecdf


Size: 3.5K
R: Plot a dip() Result, i.e., Class "dip" Object
...entirely back-compatibly. Usage ## S3 method for class 'dip' plot(x, do.points = (n < 20), colG = "red3", colL = "blue3", colM = "forest green", col.points = par("col"), col.hor = col.points, doModal...
/CRAN/refmans/diptest/html/plot.dip.html
 cran-help  matching: ecdf


Size: 3.7K
R: Nonparanormal(npn) transformation
...in d dimensions npn.func The transformation function used in the npn transformation. If npn.func = "truncation", the truncated ECDF is applied. If npn.func = "shrinkage", the shrunken ECDF is applied.
/CRAN/refmans/huge/html/huge.npn.html
 cran-help  matching: ecdf


Size: 4.0K
R: Quantile Function
...Return the inverse function of a cumulative distribution function. Usage quantilefun(x, ...) ## S3 method for class 'ecdf' quantilefun(x, ..., type=1) ## S3 method for class 'ewcdf' quantilefun(x...
/CRAN/refmans/spatstat.geom/html/quantilefun.html
 cran-help  matching: ecdf


Size: 3.3K
R: EP-means Algorithm for Clustering Empirical Distributions
...elist a length N list of either vector or ecdf objects. k the number of clusters. Value a named list containing cluster an integer vector indicating the cluster to which each ecdf is allocated.
/CRAN/refmans/maotai/html/epmeans.html
 cran-help  matching: ecdf


Size: 6.5K
R: Plot distributions fitted with L-moments
...densities or ecdf with cumulated probability Usage plotLfit( dlf, nbest = 5, selection = NULL, order = TRUE, rmse = 4, cdf = FALSE, log = FALSE, supportends = TRUE, breaks = 20, xlim = extendrange(dlf$...
/CRAN/refmans/extremeStat/html/plotLfit.html
 cran-help  matching: ecdf




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