Login
Register
Contact Us
Search
Menu
Home
Products
XLeratorDB
function packages
for SQL Server
financial
view documentation
pricing
statistics
view documentation
pricing
math
view documentation
pricing
engineering
view documentation
pricing
strings
view documentation
pricing
financial-options
view documentation
pricing
windowing
view documentation
pricing
XLeratorDB
Compilation packages
for SQL Server
Suite
incl:
financial
,
statistics
,
math
,
engineering
&
strings
pricing
Suite (Developer)
requires SQL Server Developer Edition
pricing
Suite (Subscription)
One-year non-recurring license
pricing
SuitePLUS
incl: all Suite packages PLUS
financial-options
pricing
SuitePLUS (Developer)
requires SQL Server Developer Edition, also incl:
financial-options
pricing
SuitePLUS (Subscription)
One-year non-recurring license, also incl:
financial-options
pricing
XLeratorDLL
function packages
Microsoft .NET API Library
financial (DLL)
view documentation
pricing
SQL Server not required
View All Product Pricing ...
Download Free 15 Day Trial ...
Documentation
Purchase
XLeratorDB
function packages for
SQL Server (2008 & later)
financial
statistics
math
engineering
strings
financial-options
windowing
XLeratorDB
Compilation packages for
SQL Server (2008 & later)
Suite
Suite (Developer)
Suite (Subscription)
SuitePLUS
SuitePLUS (Developer)
SuitePLUS (Subscription)
XLeratorDLL
function packages
Microsoft .NET API Library
financial (DLL)
Legacy XLeratorDB Packages for
SQL Server 2005
financial
for SQL Server 2005 only
statistics
for SQL Server 2005 only
math
for SQL Server 2005 only
Suite
for SQL Server 2005 only
Suite (Developer)
for SQL Server 2005 only
SuitePLUS
for SQL Server 2005 only
SuitePLUS (Developer)
for SQL Server 2005 only
Download Trial
Case Studies
Blog
Support
XLeratorDB/statistics Documentation
Home
Search
Recent Changes
Show All Pages
Statistics Functions Index ...
Statistical Functions
Continuous Data
Location
AVERAGE - average (arithmetic mean) of a dataset
AVERAGE_q - average (arithmetic mean) of a dataset
COUNT - count of numeric rows in a dataset
COUNT_q - count of numeric rows in a dataset
GEOMEAN - geometric mean of a dataset
GEOMEAN_q - geometric mean of a dataset
HARMEAN - harmonic mean of a dataset
HARMEAN_q - harmonic mean of a dataset
MEDIAN - median value in a dataset
MEDIAN_q - median value in a dataset
MODE - mode (most frequent value) of a dataset
MODE_q - mode (most frequent value) of a dataset
TRIMMEAN - mean of the interior of a dataset
TRIMMEAN_q - mean of the interior of a dataset
Dispersion
AVEDEV - average deviation
AVEDEV_q - average deviation
COVAR - covariance
COVAR_q - covariance
COVARIANCE_P - population covariance
COVARIANCE_S - sample covariance
DEVSQ - deviation squared
DEVSQ_q - deviation squared
IPR - inter-percentile range
IQR - inter-quartile range
KURTOSIS_P - population kurtosis
KURTOSIS_S - sample kurtosis
LARGE - kth largest value in a dataset
LARGE_q - kth largest value in a dataset
PERCENTILE - percentile
PERCENTILE_q - percentile
PERCENTILE_EXC - percentile
PERCENTILES - any number of percentiles from a set of values
PERCENTRANK - rank of a value in a dataset as a percentage of the dataset
PERCENTRANK_q - rank of a value in a dataset as a percentage of the dataset
PERCENTRANK_EXC - rank of a value in a dataset
PERCENTRANKS - relative standing of values within a dataset
QUARTILE - specified quartile of a dataset
QUARTILE_q - specified quartile of as dataset
QUARTILE_EXC - specified quartile of a dataset
RANGE - difference between the minimum and maximum values in a dataset
RANK - rank of a number in a list of numbers
RANK_q - rank of a number in a list of numbers
RANKAVG - average rank of a number in a list of numbers
SKEWNESS_P - skewness for an entire population
SKEWNESS_S - sample skewness
SMALL - kth smallest value in a dataset
SMALL_q - kth smallest value in a dataset
STDEV - estimated standard deviation based on a sample
STDEV_q - estimated standard deviation based on a sample
STDEVP - standard deviation for an entire population
STDEVP_q - standard deviation for an entire population
STDEV_P - standard deviation for an entire population
STDEV_S - estimated standard deviation based on a sample
VAR_P - variance for an entire population
VAR_S - estimate variance based on a sample
Shape
KURT - kurtosis of a dataset
KURT_q - kurtosis of a dataset
SKEW - degree of asymmetry of a distribution
SKEW_q - degree of asymmetry of a distribution
VAR - estimate variance based on a sample
VAR_q - estimate variance based on a sample
VARP - variance for an entire population
VARP_q - population variance
Statistical Inference
Specific Tests
CHISQ - chi-square (χ2) statistic
CHISQ_q - chi-square (χ2) statistic
CHISQ2 - chi-square (χ2) statistic
CHISQ2_q - chi-square (χ2) statistic
CHISQN - chi-square (χ2) statistic for data in third-normal form
CHISQN_q - chi-square (χ2) statistic for data in third-normal form
CHISQN2 - chi-square (χ2) statistic for data in third-normal form
CHISQN2_q - chi-square (χ2) statistic for data in third-normal form
CHITEST - Pearson chi-square test for independence
CHITEST_q - Pearson chi-square test for independence
CHITEST2 - Pearson chi-square test for independence
CHITEST2_q - Pearson chi-square test for independence
CHITESTN - Pearson chi-square test for independence on data in third-normal form
CHITESTN_q - Pearson chi-square test for independence on data in third-normal form
CHITESTN2 - Pearson chi-square test for independence on data in third-normal form
CHITESTN2_q - Pearson chi-square test for independence on data in third-normal form
FTEST - result of an F-test
FTEST_q - result of an F-test
KSTEST - compare a sample with a reference probability distribution
KSTEST_q - compare a sample with a reference probability distribution
KSTEST2 - two-sample Kolmogorov-Smirnov test to compare the distributions of the values in two samples
KSTEST2_q - two-sample Kolmogorov-Smirnov test to compare the distributions of the values in two samples
SFTEST - Shapiro-Francia test for the composite hypothesis of normality
SFTEST_q - Shapiro-Francia test for the composite hypothesis of normality
SWTEST - Shapiro and Wilk’s W statistic and its p-value
SWTEST_q - Shapiro and Wilk’s W statistic and its p-value
TTEST - probability associated with Student’s t-test
TTEST_q - probability associated with Student’s t-test
TTEST_INDEP - t-test on data in two samples assuming equal variance
TTEST_INDEPU - t-test on data in two samples assuming unequal variance
TTEST_PAIRED - t-test on data in two samples assuming unequal variance
ZTEST - one-tailed probability of a Z-test
ZTEST_q - one-tailed probability of a Z-test
Correlation and Regression Analysis
Correlations
CORREL - correlation coefficient between two datasets
CORREL_q - correlation coefficient between two datasets
PEARSON - Pearson product-moment coefficient between two datasets
PEARSON_q - Pearson product-moment coefficient between two datasets
PROB - probability that values in a range are between two limits
PROB_q - probability that values in a range are between two limits
RSQ - Pearson product moment correlation coefficient through data points in known-y’s and known-x’s
RSQ_q - Pearson product moment correlation coefficient through data points in known-y’s and known-x’s
Linear Regressions
EXPPRED - predicted value for a dependent variable using the coeffiecients from a previously run mutlivariate exponential regression
FORECAST - future value by using existing values
FORECAST_q - future value by using existing values
GROWTH - predicted exponential growth by using existing data
GROWTH_q - predicted exponential growth by using existing data
GROWTHMX - values along an exponential trend
GROWTHMX_q - values along an exponential trend
INTERCEPT - point at which a line will intersect the y-axis by using existing x-values and y-values
INTERCEPT_q - point at which a line will intersect the y-axis by using existing x-values and y-values
LINEST - ordinary least squares (OLS) solution for a series of x- and y-values
LINEST_q - ordinary least squares (OLS) solution for a series of x- and y-values
LMPRED - predicted value for a dependent variable using the coefficients from a previously run multivariate linear regression
LOGEST - exponential curve that best fits a series of x- and y-values
LOGEST_q - exponential curve that best fits a series of x- and y-values
SLOPE - slope of the linear regression through the data points in the known x-values and y-values
SLOPE_q - slope of the linear regression through the data points in the known x-values and y-values
TREND - values along a linear trend
TREND_q - values along a linear trend
TRENDMX - values along a linear trend
TRENDMX_q - values along a linear trend
WLS - Weighted least squares solution for a series of x- and y-values and their associated weights
WLS_q - Weighted least squares solution for a series of x- and y-values and their associated weights
Logistic Regressions
LOGIT - binary logistic regression coefficients from a table of x-values (the independent variables) and dichotomous y-values (the dependent variable)
LOGITPRED - probability that Y = 1 given a set of coefficients from a logistic regression and a set of x-values
LOGITPROB - probability that Y = 1 given a set of coefficients from a logistic regression and a set of x-values
LOGITSUM - binary logistic regression coefficients from a table of grouped x-values (the independent variables) with counts of the successes and failures for each group
ROCTable - calculation of the area under the ROC curve
VIF - R-squared
Data Collection
Sampling
KMEANS - k-means clustering in N-dimensions
STEYX - standard error of the predicted y-value for each x in a regression
STEYX_q - standard error of the predicted y-value for each x in a regression
Interobserver Agreement
ICC - intra-class coefficient
ICC_TV - intra-class coefficient
KAPPA_COHEN - Cohen’s kappa (κ) or weighted kappa as an index of inter-rater agreement between 2 raters
KAPPA_COHEN_TV - Cohen’s kappa (κ) or weighted kappa as an index of inter-rater agreement between 2 raters
KAPPA_FLEISS - Fleiss’ kappa (κ) as an index of inter-rater agreement between m raters on categorical data
KAPPA_FLEISS_TV - Fleiss’ kappa (κ) as an index of inter-rater agreement between m raters on categorical data
KENDALLT - Kendall’s tau (τ)
KENDALLT_TV - Kendall’s tau (τ)
KENDALLW - Kendall’s coefficient of concordance (w) as an index of inter-rater reliability for ordinal data
KENDALLW_TV - Kendall’s coefficient of concordance (w) as an index of inter-rater reliability for ordinal data
MCNEMAR - McNemar’s chi-squared test for symmetry of rows and columns in a two-dimensional contingency table
MCNEMAR_TV - McNemar’s chi-squared test for symmetry of rows and columns in a two-dimensional contingency table
PSIGNRANK - distribution function of the Wilcoxon Signed Rank statistic
RANK_AVG - ranks for a collection of x- and y-values
SPEARMAN - Spearman’s rank correlation coefficient (ρ)
SPEARMAN_TV - Spearman’s rank correlation coefficient (ρ)
WMPSR - Wilcoxon matched-pair signed-rank test
WMPSR_TV - Wilcoxon matched-pair signed-rank test
Probability Functions
Distributions
BETA_DIST - probability density function or cumulative distribution function of a beta distribution for x with shape parameters a and ß
BETADIST - beta cumulative probability density function
BETAINV - quartiles of the beta cumulative distribution function
BETAPDF - probability density function for the beta distribution
BINOM_DIST_RANGE - probability of a trial result using a binomial distribution
BINOMDIST - binomial distribution
BINOMINV - value of number of success in the binomial distribution given the cumulative distribution function
BIVAR - bivariate normal probabilities
CAUCHY - probability density function or the lower cumulative distribution function of the Cauchy distribution
CAUCHYINV - inverse lower cumulative distribution of the Cauchy distribution
CHI2NC - lower cumulative distribution function of the non-central chi-square distribution
CHI2NCINV - inverse of the lower cumulative distribution function of the non-central chi-square distribution
CHIDIST - one-tailed probability of the chi-square distribution
CHIINV - inverse of the one-tailed probability of the chi-square distribution
CHISQ_DIST - probability density or the lower cumulative probability of a chi-squared distribution for x and a number of degrees of freedom
CHISQ_DIST_RT - upper distribution of a chi-squared distribution for x and a number of degrees of freedom
CHISQ_INV - inverse of the left-tailed probability of a chi-squared distribution
CHISQ_INV_RT - inverse of the right-tailed probability of a chi-squared distribution
CHISQPDF - probability density function of the chi square distribution
CONFIDENCE - value that you can use to construct a confidence interval for a population mean
CONFIDENCE_NORM - confidence interval for a population mean
CONFIDENCE_T - confidence interval when you don't know the population standard deviation and are using the sample standard deviation instead
CRITBINOM - smallest value for the cumulative binomial distribution that is greater than or equal to a criterion value
DIGAMMA - digamma(z), the logarithmic derivative of the gamma function
EXPDIST - probability density function or the upper cumulative distribution function of the Exponential distribution
EXPONDIST - exponential distribution that is equivalent to the function used in EXCEL
EXPINV - inverse of the cumulative distribution function of the exponential distribution
F_DIST - probability density or the lower cumulative probability of an F-distribution for x and degrees of freedom for 2 independent random variables
F_DIST_RT - upper cumulative probability of an F-distribution for x and degrees of freedom for 2 independent random variables
FDIST - F probability distribution
FINV - inverse of the F probability distribution
FPDF - probability density function of the F distribution
FISHER - Fisher transformation at x
FISHERINV - inverse of the Fisher transformation
GAMMADIST - gamma distribution
GAMMAINV - inverse of the cumulative gamma distribution
GAMMAP - regularized gamma function P(a
GAMMAQ - regularized gamma function Q(a
GEOMETRIC - probability mass function of the geometric distribution
GEOMETRICP - cumulative distribution function of the geometric distribution
GEOMETRICINV - inverse of the cumulative distribution function of the geometric distribution
HYPGEOM_DIST - pmf or the cdf of the hypergeometric distribution
HYPGEOM_INV - quantiles of the hypergeometric distribution
HYPGEOMDIST - hypergeometric distribution
HYPGEOMDISTP - lower cumulative distribution of the hypergeometric function
HYPGEOMDISTPINV - inverse of the cumulative distribution function of the hypergeometric distribution
HYPGEOMDISTQ - upper cumulative distribution of the hypergeometric function
INVGAMMAP - inverse of the incomplete gamma function P(a
KScdf - cumulative probability P[Dn >= x] of the Kolmogorov-Smirnov distribution with sample size n at x
KSccdf - complementary cumulative probability P[Dn >= x] of the Kolmogorov-Smirnov distribution with sample size n at x
KSP - Kolmogorov-Smirnov (KS) cumulative distribution function
KSPINV - inverse of the Kolmogorov-Smirnov (KS) cumulative distribution function
KSQ - complementary Kolmogorov-Smirnov (KS) cumulative distribution function
KSQINV - inverse of the complementary Kolmogorov-Smirnov (KS) cumulative distribution function
LAPLACE - probability density function or the lower cumulative distribution function of the Laplace distribution
LAPLACEINV - inverse lower cumulative distribution of the Laplace distribution
LOGINV - inverse of the lognormal cumulative distribution function of x where ln(x) is normally distributed within the parameters mean and standard deviation
LOGISTIC - probability density function or the lower cumulative distribution function of the logistic distribution
LOGISTICINV - inverse lower cumulative distribution of the logistic distribution
LOGNORM_DIST - probability density function or the cumulative distributive function of the normal distribution of x
LOGNORM_INV - inverse of the lognormal distribution function of x
LOGNORMDIST - lognormal cumulative distribution function of x where ln(x) is normally distributed within the parameters mean and standard deviation
LOGNORMPDF - probability density function of the lognormal distribution
NCFCDF - lower cumulative distribution function of the non-central F distribution
NCFINV - inverse of the lower cumulative distribution function of the non-central F distribution
NCFPDF - probability density function of the non-central F distribution
NCHISQPDF - probability density function of the non-central chi square distribution
NCTCDF - lower cumulative distribution function of the non-central T distribution
NCTINV - inverse of the lower cumulative distribution function of the non-central T distribution
NCTPDF - probability density function of the non-central T distribution
NEGBINOM_DIST - probability mass function or the cumulative distributive function of the negative binomial distribution
NEGBINOMDIST - negative binomial distribution
NEGBINOMDISTP - cumulative distribution function of the negative binomial distribution
NEGBINOMINV - smallest value of x such that NEGBINOMDISTP(x
NEGHYPGEOM_DIST - probability mass function or the cumulative distributive function of the negative hypergeometric distribution
NEGHYPGEOM_INV - quantiles of the negative hypergeometric distribution
NORMAL - probability density function for the standard normal distribution
NORM_S_DIST - probability density function or the lower cumulative distribution function of the standard normal distribution in SQL Server
NORMDIST - normal distribution for the specified mean and standard deviation
NORMINV - inverse of the normal cumulative distribution function (cdf)
NORMSDIST - standard normal cumulative distribution function
NORMSINV - inverse of the standard normal distribution in SQL Server
POISSON - Poisson distribution
POISSON_DIST - probability mass function or the lower cumulative probability of a Poisson distribution for a given number of events occurring in a fixed interval given the rate
POISSONINV - inverse of the cumulative distribution function of the Poisson distribution
STANDARDIZE - normalized value from a distribution characterized by a mean and standard deviation
STUDENTST - Student’s t-distribution
T_DIST - probability density function and the left-tailed cumulative probability distribution of Student's t-distribution
T_DIST_2T - two-tailed cumulative probability distribution of Student's t-distribution
T_DIST_RT - right-tailed cumulative probability distribution of Student's t-distribution
TDIST - probability for the Student t-distribution where a numeric value (x) is a calculated value of t for which the probability is to be computed
T_INV - inverse of the left-tailed cumulative probability distribution of Student's t-distribution
T_INV_2T - inverse of the two-tailed distribution of Student's t-distribution
TINV - t-value of the Student's t-distribution as a function of the probability and the degrees of freedom
TPDF - probability density function of the T distribution
TRIGAMMA - trigamma(z) the second derviative of the natural log of the gamma function
UNIFORM - probability density function or the lower cumulative distribution function of the uniform distribution
UNIFORMINV - inverse of the lower cumulative distribution of the uniform distribution
WEIBULL - Weibull distribution
WEIBULLINV - inverse of the cumulative distribution function of the Weibull distribution
Combinatorics
BETA - beta function
BETAI - incomplete beta function
BICO - binomial coefficient
FACTLN - natural logarithm of a factorial
FACTORIALPOWER - rising or falling factorials
GAMMA - invoke the (complete) gamma function Γ(x)
GAMMAINC - incomplete gamma function
GAMMALN - natural logarithm of the (complete) gamma function Γ(x)
LCHOOSE - natural logarithm of the binomial coefficient
LPERMUT - natural logarithm of the PERMUT function
LPERMUTA - natural logarithm of the PERMUTATIONA function
MULTINOM - to calculate the probability distribution of the outcomes of a multinomial experiment
PERMUT - number of permutations for a given number objects that can be selected from a number of objects
PERMUTATIONA - number of permutations with replacement
STIRLING1 - stirling number of the first kind
STIRLING2 - stirling number of the second kind
Misc Functions
XLDB_STATISTICS_VERSION - version information for the XLeratorDB/statistics module
SAMPLE DATA - sample data for certain XLeratorDB/statistics functions documentation
ALL FUNCTIONS (alpahbetical)
AVEDEV - average deviation
AVEDEV_q - average deviation
AVERAGE - average (arithmetic mean) of a dataset
AVERAGE_q - average (arithmetic mean) of a dataset
BETA - beta function
BETA_DIST - probability density function or cumulative distribution function of a beta distribution for x with shape parameters a and ß
BETADIST - beta cumulative probability density function
BETAI - incomplete beta function
BETAINV - quartiles of the beta cumulative distribution function
BETAPDF - probability density function for the beta distribution
BICO - binomial coefficient
BINOM_DIST_RANGE - probability of a trial result using a binomial distribution
BINOMDIST - binomial distribution
BINOMINV - value of number of success in the binomial distribution given the cumulative distribution function
BIVAR - bivariate normal probabilities
CAUCHY - probability density function or the lower cumulative distribution function of the Cauchy distribution
CAUCHYINV - inverse lower cumulative distribution of the Cauchy distribution
CHI2NC - lower cumulative distribution function of the non-central chi-square distribution
CHI2NCINV - inverse of the lower cumulative distribution function of the non-central chi-square distribution
CHIDIST - one-tailed probability of the chi-square distribution
CHIINV - inverse of the one-tailed probability of the chi-square distribution
CHISQ - chi-square (χ2) statistic
CHISQ_DIST - probability density or the lower cumulative probability of a chi-squared distribution for x and a number of degrees of freedom
CHISQ_DIST_RT - upper distribution of a chi-squared distribution for x and a number of degrees of freedom
CHISQ_INV - inverse of the left-tailed probability of a chi-squared distribution
CHISQ_INV_RT - inverse of the right-tailed probability of a chi-squared distribution
CHISQ_q - chi-square (χ2) statistic
CHISQ2 - chi-square (χ2) statistic
CHISQ2_q - chi-square (χ2) statistic
CHISQN - chi-square (χ2) statistic for data in third-normal form
CHISQN_q - chi-square (χ2) statistic for data in third-normal form
CHISQN2 - chi-square (χ2) statistic for data in third-normal form
CHISQN2_q - chi-square (χ2) statistic for data in third-normal form
CHISQPDF - probability density function of the chi square distribution
CHITEST - Pearson chi-square test for independence
CHITEST_q - Pearson chi-square test for independence
CHITEST2 - Pearson chi-square test for independence
CHITEST2_q - Pearson chi-square test for independence
CHITESTN - Pearson chi-square test for independence on data in third-normal form
CHITESTN_q - Pearson chi-square test for independence on data in third-normal form
CHITESTN2 - Pearson chi-square test for independence on data in third-normal form
CHITESTN2_q - Pearson chi-square test for independence on data in third-normal form
CONFIDENCE - value that you can use to construct a confidence interval for a population mean
CONFIDENCE_NORM - confidence interval for a population mean
CONFIDENCE_T - confidence interval when you don't know the population standard deviation and are using the sample standard deviation instead
CORREL - correlation coefficient between two datasets
CORREL_q - correlation coefficient between two datasets
COUNT - count of numeric rows in a dataset
COUNT_q - count of numeric rows in a dataset
COVAR - covariance
COVAR_q - covariance
COVARIANCE_P - population covariance
COVARIANCE_S - sample covariance
CRITBINOM - smallest value for the cumulative binomial distribution that is greater than or equal to a criterion value
DEVSQ - deviation squared
DEVSQ_q - deviation squared
DIGAMMA - digamma(z), the logarithmic derivative of the gamma function
EXPDIST - probability density function or the upper cumulative distribution function of the Exponential distribution
EXPINV - inverse of the cumulative distribution function of the exponential distribution
EXPONDIST - exponential distribution that is equivalent to the function used in EXCEL
EXPPRED - predicted value for a dependent variable using the coeffiecients from a previously run mutlivariate exponential regression
F_DIST - probability density or the lower cumulative probability of an F-distribution for x and degrees of freedom for 2 independent random variables
F_DIST_RT - upper cumulative probability of an F-distribution for x and degrees of freedom for 2 independent random variables
F_INV - inverse of the F lower probability distribution
F_INV_RT - inverse of the F upper probability distribution
FACTLN - natural logarithm of a factorial
FACTORIALPOWER - rising or falling factorials
FDIST - F probability distribution
FINV - inverse of the F probability distribution
FISHER - Fisher transformation at x
FISHERINV - inverse of the Fisher transformation
FORECAST - future value by using existing values
FORECAST_q - future value by using existing values
FPDF - probability density function of the F distribution
FTEST - result of an F-test
FTEST_q - result of an F-test
GAMMA - invoke the (complete) gamma function Γ(x)
GAMMADIST - gamma distribution
GAMMAINC - incomplete gamma function
GAMMAINV - inverse of the cumulative gamma distribution
GAMMALN - natural logarithm of the (complete) gamma function Γ(x)
GAMMAP - regularized gamma function P(a
GAMMAQ - regularized gamma function Q(a
GEOMEAN - geometric mean of a dataset
GEOMEAN_q - geometric mean of a dataset
GEOMETRIC - probability mass function of the geometric distribution
GEOMETRICINV - inverse of the cumulative distribution function of the geometric distribution
GEOMETRICP - cumulative distribution function of the geometric distribution
GROWTH - predicted exponential growth by using existing data
GROWTH_q - predicted exponential growth by using existing data
GROWTHMX - values along an exponential trend
GROWTHMX_q - values along an exponential trend
HARMEAN - harmonic mean of a dataset
HARMEAN_q - harmonic mean of a dataset
HYPGEOM_DIST - pmf or the cdf of the hypergeometric distribution
HYPGEOM_INV - quantiles of the hypergeometric distribution
HYPGEOMDIST - hypergeometric distribution
HYPGEOMDISTP - lower cumulative distribution of the hypergeometric function
HYPGEOMDISTPINV - inverse of the cumulative distribution function of the hypergeometric distribution
HYPGEOMDISTQ - upper cumulative distribution of the hypergeometric function
ICC - intra-class coefficient
ICC_TV - intra-class coefficient
INTERCEPT - point at which a line will intersect the y-axis by using existing x-values and y-values
INTERCEPT_q - point at which a line will intersect the y-axis by using existing x-values and y-values
INVGAMMAP - inverse of the incomplete gamma function P(a
IPR - inter-percentile range
IQR - inter-quartile range
KAPPA_COHEN - Cohen’s kappa (κ) or weighted kappa as an index of inter-rater agreement between 2 raters
KAPPA_COHEN_TV - Cohen’s kappa (κ) or weighted kappa as an index of inter-rater agreement between 2 raters
KAPPA_FLEISS - Fleiss’ kappa (κ) as an index of inter-rater agreement between m raters on categorical data
KAPPA_FLEISS_TV - Fleiss’ kappa (κ) as an index of inter-rater agreement between m raters on categorical data
KENDALLT - Kendall’s tau (τ)
KENDALLT_TV - Kendall’s tau (τ)
KENDALLW - Kendall’s coefficient of concordance (w) as an index of inter-rater reliability for ordinal data
KENDALLW_TV - Kendall’s coefficient of concordance (w) as an index of inter-rater reliability for ordinal data
KMEANS - k-means clustering in N-dimensions
KSccdf - complementary cumulative probability P[Dn >= x] of the Kolmogorov-Smirnov distribution with sample size n at x
KScdf - cumulative probability P[Dn >= x] of the Kolmogorov-Smirnov distribution with sample size n at x
KSP - Kolmogorov-Smirnov (KS) cumulative distribution function
KSPINV - inverse of the Kolmogorov-Smirnov (KS) cumulative distribution function
KSQ - complementary Kolmogorov-Smirnov (KS) cumulative distribution function
KSQINV - inverse of the complementary Kolmogorov-Smirnov (KS) cumulative distribution function
KSTEST - compare a sample with a reference probability distribution
KSTEST_q - compare a sample with a reference probability distribution
KSTEST2 - two-sample Kolmogorov-Smirnov test to compare the distributions of the values in two samples
KSTEST2_q - two-sample Kolmogorov-Smirnov test to compare the distributions of the values in two samples
KURT - kurtosis of a dataset
KURT_q - kurtosis of a dataset
KURTOSIS_P - population kurtosis
KURTOSIS_S - sample kurtosis
LAPLACE - probability density function or the lower cumulative distribution function of the Laplace distribution
LAPLACEINV - inverse lower cumulative distribution of the Laplace distribution
LARGE - kth largest value in a dataset
LARGE_q - kth largest value in a dataset
LCHOOSE - natural logarithm of the binomial coefficient
LINEST - ordinary least squares (OLS) solution for a series of x- and y-values
LINEST_q - ordinary least squares (OLS) solution for a series of x- and y-values
LMPRED - predicted value for a dependent variable using the coefficients from a previously run multivariate linear regression
LOGEST - exponential curve that best fits a series of x- and y-values
LOGEST_q - exponential curve that best fits a series of x- and y-values
LOGINV - inverse of the lognormal cumulative distribution function of x where ln(x) is normally distributed within the parameters mean and standard deviation
LOGISTIC - probability density function or the lower cumulative distribution function of the logistic distribution
LOGISTICINV - inverse lower cumulative distribution of the logistic distribution
LOGIT - binary logistic regression coefficients from a table of x-values (the independent variables) and dichotomous y-values (the dependent variable)
LOGITPRED - probability that Y = 1 given a set of coefficients from a logistic regression and a set of x-values
LOGITPROB - probability that Y = 1 given a set of coefficients from a logistic regression and a set of x-values
LOGITSUM - binary logistic regression coefficients from a table of grouped x-values (the independent variables) with counts of the successes and failures for each group
LOGNORM_DIST - probability density function or the cumulative distributive function of the normal distribution of x
LOGNORM_INV - inverse of the lognormal distribution function of x
LOGNORMDIST - lognormal cumulative distribution function of x where ln(x) is normally distributed within the parameters mean and standard deviation
LOGNORMPDF - probability density function of the lognormal distribution
LPERMUT - natural logarithm of the PERMUT function
LPERMUTA - natural logarithm of the PERMUTATIONA function
MCNEMAR - McNemar’s chi-squared test for symmetry of rows and columns in a two-dimensional contingency table
MCNEMAR_TV - McNemar’s chi-squared test for symmetry of rows and columns in a two-dimensional contingency table
MEDIAN - median value in a dataset
MEDIAN_q - median value in a dataset
MODE - mode (most frequent value) of a dataset
MODE_q - mode (most frequent value) of a dataset
MULTINOM - to calculate the probability distribution of the outcomes of a multinomial experiment
NCFCDF - lower cumulative distribution function of the non-central F distribution
NCFINV - inverse of the lower cumulative distribution function of the non-central F distribution
NCFPDF - probability density function of the non-central F distribution
NCHISQPDF - probability density function of the non-central chi square distribution
NCTCDF - lower cumulative distribution function of the non-central T distribution
NCTINV - inverse of the lower cumulative distribution function of the non-central T distribution
NCTPDF - probability density function of the non-central T distribution
NEGBINOM_DIST - probability mass function or the cumulative distributive function of the negative binomial distribution
NEGBINOMDIST - negative binomial distribution
NEGBINOMDISTP - cumulative distribution function of the negative binomial distribution
NEGBINOMINV - smallest value of x such that NEGBINOMDISTP(x
NEGHYPGEOM_DIST - probability mass function or the cumulative distributive function of the negative hypergeometric distribution
NEGHYPGEOM_INV - quantiles of the negative hypergeometric distribution
NORM_S_DIST - probability density function or the lower cumulative distribution function of the standard normal distribution in SQL Server
NORMAL - probability density function for the standard normal distribution
NORMDIST - normal distribution for the specified mean and standard deviation
NORMINV - inverse of the normal cumulative distribution function (cdf)
NORMSDIST - standard normal cumulative distribution function
NORMSINV - inverse of the standard normal distribution in SQL Server
PEARSON - Pearson product-moment coefficient between two datasets
PEARSON_q - Pearson product-moment coefficient between two datasets
PERCENTILE - percentile
PERCENTILE_EXC - percentile
PERCENTILE_q - percentile
PERCENTILES - any number of percentiles from a set of values
PERCENTRANK - rank of a value in a dataset as a percentage of the dataset
PERCENTRANK_EXC - rank of a value in a dataset
PERCENTRANK_q - rank of a value in a dataset as a percentage of the dataset
PERCENTRANKS - relative standing of values within a dataset
PERMUT - number of permutations for a given number objects that can be selected from a number of objects
PERMUTATIONA - number of permutations with replacement
POISSON - Poisson distribution
POISSON_DIST - probability mass function or the lower cumulative probability of a Poisson distribution for a given number of events occurring in a fixed interval given the rate
POISSONINV - inverse of the cumulative distribution function of the Poisson distribution
PROB - probability that values in a range are between two limits
PROB_q - probability that values in a range are between two limits
PSIGNRANK - distribution function of the Wilcoxon Signed Rank statistic
QUARTILE - specified quartile of a dataset
QUARTILE_EXC - specified quartile of a dataset
QUARTILE_q - specified quartile of as dataset
RANGE - difference between the minimum and maximum values in a dataset
RANK - rank of a number in a list of numbers
RANK_AVG - ranks for a collection of x- and y-values
RANK_q - rank of a number in a list of numbers
RANKAVG - average rank of a number in a list of numbers
ROCTable - calculation of the area under the ROC curve
RSQ - Pearson product moment correlation coefficient through data points in known-y’s and known-x’s
RSQ_q - Pearson product moment correlation coefficient through data points in known-y’s and known-x’s
SFTEST - Shapiro-Francia test for the composite hypothesis of normality
SFTEST_q - Shapiro-Francia test for the composite hypothesis of normality
SKEW - degree of asymmetry of a distribution
SKEW_q - degree of asymmetry of a distribution
SKEWNESS_P - skewness for an entire population
SKEWNESS_S - sample skewness
SLOPE - slope of the linear regression through the data points in the known x-values and y-values
SLOPE_q - slope of the linear regression through the data points in the known x-values and y-values
SMALL - kth smallest value in a dataset
SMALL_q - kth smallest value in a dataset
SPEARMAN - Spearman’s rank correlation coefficient (ρ)
SPEARMAN_TV - Spearman’s rank correlation coefficient (ρ)
STANDARDIZE - normalized value from a distribution characterized by a mean and standard deviation
STDEV - estimated standard deviation based on a sample
STDEV_P - standard deviation for an entire population
STDEV_q - estimated standard deviation based on a sample
STDEV_S - estimated standard deviation based on a sample
STDEVP - standard deviation for an entire population
STDEVP_q - standard deviation for an entire population
STEYX - standard error of the predicted y-value for each x in a regression
STEYX_q - standard error of the predicted y-value for each x in a regression
STIRLING1 - stirling number of the first kind
STIRLING2 - stirling number of the second kind
STUDENTST - Student’s t-distribution
SWTEST - Shapiro and Wilk’s W statistic and its p-value
SWTEST_q - Shapiro and Wilk’s W statistic and its p-value
T_DIST - probability density function and the left-tailed cumulative probability distribution of Student's t-distribution
T_DIST_2T - two-tailed cumulative probability distribution of Student's t-distribution
T_DIST_RT - right-tailed cumulative probability distribution of Student's t-distribution
T_INV - inverse of the left-tailed cumulative probability distribution of Student's t-distribution
T_INV_2T - inverse of the two-tailed distribution of Student's t-distribution
TDIST - probability for the Student t-distribution where a numeric value (x) is a calculated value of t for which the probability is to be computed
TINV - t-value of the Student's t-distribution as a function of the probability and the degrees of freedom
TPDF - probability density function of the T distribution
TREND - values along a linear trend
TREND_q - values along a linear trend
TRENDMX - values along a linear trend
TRENDMX_q - values along a linear trend
TRIGAMMA - trigamma(z) the second derviative of the natural log of the gamma function
TRIMMEAN - mean of the interior of a dataset
TRIMMEAN_q - mean of the interior of a dataset
TTEST - probability associated with Student’s t-test
TTEST_INDEP - t-test on data in two samples assuming equal variance
TTEST_INDEPU - t-test on data in two samples assuming unequal variance
TTEST_PAIRED - t-test on data in two samples assuming unequal variance
TTEST_q - probability associated with Student’s t-test
UNIFORM - probability density function or the lower cumulative distribution function of the uniform distribution
UNIFORMINV - inverse of the lower cumulative distribution of the uniform distribution
VAR - estimate variance based on a sample
VAR_P - variance for an entire population
VAR_q - estimate variance based on a sample
VAR_S - estimate variance based on a sample
VARP - variance for an entire population
VARP_q - population variance
VIF - R-squared
WEIBULL - Weibull distribution
WEIBULLINV - inverse of the cumulative distribution function of the Weibull distribution
WLS - Weighted least squares solution for a series of x- and y-values and their associated weights
WLS_q - Weighted least squares solution for a series of x- and y-values and their associated weights
WMPSR - Wilcoxon matched-pair signed-rank test
WMPSR_TV - Wilcoxon matched-pair signed-rank test
XLDB_STATISTICS_VERSION - version information for the XLeratorDB/statistics module
ZTEST - one-tailed probability of a Z-test
ZTEST_q - one-tailed probability of a Z-test
All Wiki Pages
 
Home
 
AVEDEV
 
AVEDEV - 2008
 
AVEDEV_q
 
AVERAGE
 
AVERAGE_q
 
BETA
 
BETA_DIST
 
BETADIST
 
BETAI
 
BETAINV
 
BETAPDF
 
BICO
 
BINOM_DIST_RANGE
 
BINOMDIST
 
BINOMINV
 
BIVAR
 
CAUCHY
 
CAUCHYINV
 
CHI2NC
 
CHI2NCINV
 
CHIDIST
 
CHIINV
 
CHISQ
 
CHISQ_DIST
 
CHISQ_DIST_RT
 
CHISQ_INV
 
CHISQ_INV_RT
 
CHISQ_q
 
CHISQ2
 
CHISQ2_q
 
CHISQN
 
CHISQN - 2008
 
CHISQN_q
 
CHISQN2
 
CHISQN2 - 2008
 
CHISQN2_q
 
CHISQPDF
 
CHITEST
 
CHITEST_q
 
CHITEST2
 
CHITEST2_q
 
CHITESTN
 
CHITESTN - 2008
 
CHITESTN_q
 
CHITESTN2
 
CHITESTN2 - 2008
 
CHITESTN2_q
 
CONFIDENCE
 
CONFIDENCE_NORM
 
CONFIDENCE_T
 
CORREL
 
CORREL - 2008
 
CORREL_q
 
COUNT
 
COUNT_q
 
COVAR
 
COVAR - 2008
 
COVAR_q
 
COVARIANCE_P
 
COVARIANCE_P - 2008
 
COVARIANCE_S
 
COVARIANCE_S - 2008
 
CRITBINOM
 
DEVSQ
 
DEVSQ - 2008
 
DEVSQ_q
 
DIGAMMA
 
EXPDIST
 
EXPINV
 
EXPONDIST
 
EXPPRED
 
F_DIST
 
F_DIST_RT
 
F_INV
 
F_INV_RT
 
FACTLN
 
FACTORIALPOWER
 
FDIST
 
FINV
 
FISHER
 
FISHERINV
 
FORECAST
 
FORECAST - 2008
 
FORECAST_q
 
FPDF
 
FTEST
 
FTEST - 2008
 
FTEST_q
 
GAMMA
 
GAMMADIST
 
GAMMAINC
 
GAMMAINV
 
GAMMALN
 
GAMMAP
 
GAMMAQ
 
GEOMEAN
 
GEOMEAN - 2008
 
GEOMEAN_q
 
GEOMETRIC
 
GEOMETRICINV
 
GEOMETRICP
 
GROWTH
 
GROWTH - 2008
 
GROWTH_q
 
GROWTHMX
 
GROWTHMX_q
 
HARMEAN
 
HARMEAN - 2008
 
HARMEAN_q
 
HYPGEOM_DIST
 
HYPGEOM_INV
 
HYPGEOMDIST
 
HYPGEOMDISTP
 
HYPGEOMDISTPINV
 
HYPGEOMDISTQ
 
ICC
 
ICC_TV
 
INTERCEPT
 
INTERCEPT - 2008
 
INTERCEPT_q
 
INVGAMMAP
 
IPR - 2008
 
IQR - 2008
 
KAPPA_COHEN
 
KAPPA_COHEN_TV
 
KAPPA_FLEISS
 
KAPPA_FLEISS_TV
 
KENDALLT
 
KENDALLT_TV
 
KENDALLW
 
KENDALLW_TV
 
KMEANS
 
KSccdf
 
KScdf
 
KSP
 
KSPINV
 
KSQ
 
KSQINV
 
KSTEST
 
KSTEST - 2008
 
KSTEST_q
 
KSTEST2
 
KSTEST2 - 2008
 
KSTEST2_q
 
KURT
 
KURT - 2008
 
KURT_q
 
KURTOSIS_P
 
KURTOSIS_S
 
LAPLACE
 
LAPLACEINV
 
LARGE
 
LARGE - 2008
 
LARGE_q
 
LCHOOSE
 
LINEST
 
LINEST_q
 
LMPRED
 
LOGEST
 
LOGEST_q
 
LOGINV
 
LOGISTIC
 
LOGISTICINV
 
LOGIT
 
LOGITPRED
 
LOGITPROB
 
LOGITSUM
 
LOGNORM_DIST
 
LOGNORM_INV
 
LOGNORMDIST
 
LOGNORMPDF
 
LPERMUT
 
LPERMUTA
 
MCNEMAR
 
MCNEMAR_TV
 
MEDIAN
 
MEDIAN - 2008
 
MEDIAN_q
 
MODE
 
MODE - 2008
 
MODE_q
 
MULTINOM
 
NCFCDF
 
NCFINV
 
NCFPDF
 
NCHISQPDF
 
NCTCDF
 
NCTINV
 
NCTPDF
 
NEGBINOM_DIST
 
NEGBINOMDIST
 
NEGBINOMDISTP
 
NEGBINOMINV
 
NEGHYPGEOM_DIST
 
NEGHYPGEOM_INV
 
NORM_S_DIST
 
NORMAL
 
NORMDIST
 
NORMINV
 
NORMSDIST
 
NORMSINV
 
PEARSON
 
PEARSON - 2008
 
PEARSON_q
 
PERCENTILE
 
PERCENTILE - 2008
 
PERCENTILE_EXC - 2008
 
PERCENTILE_q
 
PERCENTILES
 
PERCENTRANK
 
PERCENTRANK - 2008
 
PERCENTRANK_EXC - 2008
 
PERCENTRANK_q
 
PERCENTRANKS
 
PERMUT
 
PERMUTATIONA
 
POISSON
 
POISSON_DIST
 
POISSONINV
 
PROB
 
PROB - 2008
 
PROB_q
 
PSIGNRANK
 
QUARTILE
 
QUARTILE - 2008
 
QUARTILE_EXC - 2008
 
QUARTILE_q
 
RANGE - 2008
 
RANK
 
RANK - 2008
 
RANK_AVG
 
RANK_q
 
RANKAVG - 2008
 
ROCTable
 
RSQ
 
RSQ - 2008
 
RSQ_q
 
SFTEST
 
SFTEST - 2008
 
SFTEST_q
 
SKEW
 
SKEW - 2008
 
SKEW_q
 
SKEWNESS_P
 
SKEWNESS_S
 
SLOPE
 
SLOPE - 2008
 
SLOPE_q
 
SMALL
 
SMALL - 2008
 
SMALL_q
 
SPEARMAN
 
SPEARMAN_TV
 
STANDARDIZE
 
STDEV
 
STDEV - 2008
 
STDEV_P
 
STDEV_q
 
STDEV_S
 
STDEVP
 
STDEVP - 2008
 
STDEVP_q
 
STEYX
 
STEYX - 2008
 
STEYX_q
 
STIRLING1
 
STIRLING2
 
STUDENTST
 
SWTEST
 
SWTEST - 2008
 
SWTEST_q
 
T_DIST
 
T_DIST_2T
 
T_DIST_RT
 
T_INV
 
T_INV_2T
 
TDIST
 
TINV
 
TPDF
 
TREND
 
TREND - 2008
 
TREND_q
 
TRENDMX
 
TRENDMX_q
 
TRIGAMMA
 
TRIMMEAN
 
TRIMMEAN - 2008
 
TRIMMEAN_q
 
TTEST
 
TTEST - 2008
 
TTEST_INDEP
 
TTEST_INDEP - 2008
 
TTEST_INDEPU
 
TTEST_INDEPU - 2008
 
TTEST_PAIRED
 
TTEST_PAIRED - 2008
 
TTEST_q
 
UNIFORM
 
UNIFORMINV
 
VAR
 
VAR - 2008
 
VAR_P
 
VAR_q
 
VAR_S
 
VARP
 
VARP - 2008
 
VARP_q
 
VIF
 
WEIBULL
 
WEIBULLINV
 
WLS
 
WLS_q
 
WMPSR
 
WMPSR_TV
 
XLDB Statistics Sample Data
 
XLDB_STATISTICS_VERSION
 
ZTEST
 
ZTEST - 2008
 
ZTEST_q