Package Cl-Mathstats - Internal and External Symbols

Part of:

asdf-system tinaa, asdf-system cl-graph, asdf-system cl-mathstats

Package Cl-Mathstats uses the packages Common-Lisp, Metabang.Cl-Containers and Metabang.Utilities. It is also known as Metabang.Math. It has 784 total symbols and 106 external ones.

Condition

data-error
enormous-contingency-table
insufficient-data
no-data
not-binary-variables
unmatched-sequences
zero-standard-deviation
zero-variance

Class

anova-one-way-variables
anova-two-way-variables
anova-two-way-variables-unequal-cell-sizes
autocorrelation
composite-statistic
confidence-interval
confidence-interval-proportion
confidence-interval-t
confidence-interval-z
correlation
covariance
cross-correlation
d-test
data
data-length
interquartile-range
maximum
mean
median
minimum
mode
multiple-modes
quantile
range
significance
simple-statistic
skewness
standard-deviation
statistic
statistical-summary
t-significance
t-test
t-test-matched
t-test-one-sample
trimmed-mean
tukey-summary
variance
z-test-one-sample

Variable

*continous-data-window-divisor*
*continuous-variable-uniqueness-factor*
*create-statistical-objects*
*gaussian-cdf-signals-zero-standard-deviation-error*
*temporary-table*
*temporary-vector*
*way-too-big-contingency-table-dimension*

Constant

+0degrees+
+10degrees+
+120degrees+
+135degrees+
+150degrees+
+15degrees+
+180degrees+
+210degrees+
+225degrees+
+240degrees+
+270degrees+
+300degrees+
+30degrees+
+315degrees+
+330degrees+
+360degrees+
+45degrees+
+5degrees+
+60degrees+
+90degrees+
+e+
+log-pi+
+sqrt-pi+
2fpiThe constant 2*pi, in single-float format. Using this constant avoid run-time double-float conta...
fpiThe constant pi, in single-float format. Using this constant avoid run-time double-float contagi...

Function

1-or-2d-arrayp
anova-one-way-groupsPerforms a one-way analysis of variance (ANOVA) on the `data,' which should be a sequence of sequ...
anova-one-way-variablesANOVA-ONE-WAY-VARIABLES (IV DV &OPTIONAL (SCHEFFE-TESTS-P T)
CONFIDENCE-...
anova-one-way-variables-internalSee ANOVA-ONE-WAY-VARIABLES
anova-two-way-groupsCalculates the analysis of variance when there are two factors that may affect the dependent vari...
anova-two-way-variablesANOVA-TWO-WAY-VARIABLES (DV IV1 IV2)
Calculates the analysis of variance when there are two facto...
anova-two-way-variables-internalSee ANOVA-TWO-WAY-VARIABLES
anova-two-way-variables-unequal-cell-sizesANOVA-TWO-WAY-VARIABLES-UNEQUAL-CELL-SIZES (IV1 IV2 DV)
Calculates the analysis of variance when ...
anova-two-way-variables-unequal-cell-sizes-internalSee ANOVA-TWO-WAY-VARIABLES-UNEQUAL-CELL-SIZES
autocorrelationAUTOCORRELATION (SAMPLE MAX-LAG &OPTIONAL (MIN-LAG 0))
Autocorrelation is merely a cross-correlat...
autocorrelation-internalSee AUTOCORRELATION
betaReturns the value of the Beta function, defined in terms of the complete gamma function, G, as: G...
beta-incompleteThis function is useful in defining the cumulative distributions for Student's t and the F distri...
binomial-cdfSuppose an event occurs with probability `p' per trial. This function computes the probability o...
binomial-cdf-exactThis is an exact but computationally intensive form of the preferred function, `binomial-cdf.'
binomial-coefficientReturns the binomial coefficient, `n' choose `k,' as an integer. The result may not be exactly c...
binomial-coefficient-exactThis is an exact but computationally intensive form of the preferred function, `binomial-coeffici...
binomial-probabilityReturns the probability of `k' successes in `n' trials, where at each trial the probability of su...
binomial-probability-exactThis is an exact but computationally intensive form of the preferred function, `binomial-probabil...
chi-square-2x2Performs a chi-square test for independence of the two variables, `v1' and `v2.' These should be ...
chi-square-2x2-countsRuns a chi-square test for association on a simple 2 x 2 table. If `yates' is nil, the correctio...
chi-square-rxcPerforms a chi-square test for independence of the two variables, `v1' and `v2.' These should be ...
chi-square-rxc-countsCalculates the chi-square statistic and corresponding p-value for the given contingency table. T...
chi-square-significanceComputes the complement of the cumulative distribution function for a Chi-square random variable ...
combination-countReturns the number of combinations of n elements taken k at a time. Assumes valid input.
confidence-intervalCONFIDENCE-INTERVAL NIL
NIL
confidence-interval-internal
confidence-interval-proportionCONFIDENCE-INTERVAL-PROPORTION (X N CONFIDENCE)
Suppose we have a sample of `n' things and `x' of...
confidence-interval-proportion-internalSee CONFIDENCE-INTERVAL-PROPORTION
confidence-interval-tCONFIDENCE-INTERVAL-T (DATA CONFIDENCE)
Suppose you have a sample of 10 numbers and you want to c...
confidence-interval-t-internalSee CONFIDENCE-INTERVAL-T
confidence-interval-t-summariesThis function is just like `confidence-interval-t,' except that instead of its arguments being th...
confidence-interval-zCONFIDENCE-INTERVAL-Z (DATA CONFIDENCE)
Suppose you have a sample of 50 numbers and you want to c...
confidence-interval-z-internalSee CONFIDENCE-INTERVAL-Z
confidence-interval-z-summariesThis function is just like `confidence-interval-z,' except that instead of its arguments being th...
correlationCORRELATION (SAMPLE1 SAMPLE2 &KEY START1 END1 START2 END2)
Computes the correlation coefficient o...
correlation-from-summariesComputes the correlation of two variables given summary statistics of the variables. All of thes...
correlation-internalSee CORRELATION
correlation-matrixReturns a matrix of all the correlations of all the variables. The dependent variable is row and...
covarianceCOVARIANCE (SAMPLE1 SAMPLE2 &KEY START1 END1 START2 END2)
Computes the covariance of two samples,...
covariance-internalSee COVARIANCE
cross-correlationCROSS-CORRELATION (SEQUENCE1 SEQUENCE2 MAX-LAG &OPTIONAL (MIN-LAG 0))
Returns a list of the corre...
cross-correlation-internalSee CROSS-CORRELATION
d-testD-TEST (SAMPLE-1 SAMPLE-2 TAILS &KEY (TIMES 1000) (H0MEAN 0))
Two-sample test for difference in m...
d-test-internalSee D-TEST
data-continuous-p
data-lengthDATA-LENGTH (DATA &KEY START END KEY)
Returns the number of data values in `data.' Essentially, t...
data-length-internalSee DATA-LENGTH
degrees->radiansConvert degrees to radians.
difference-listTakes a sequence of numbers and returns a sequence of differences from the mean. Formula: xi = X...
div2Divide positive fixnum `i' by 2 or a power of 2, yielding an integer result. For example, (div2 3...
ensure-float
error-functionComputes the error function, which is typically used to compute areas under the Gaussian probabil...
error-function-complementThis function computes the complement of the error function, ``erfc(x),'' defined as 1-erf(x). S...
error-function-complement-short-1
error-function-complement-short-2
exp22^n
extract-unique-valuesA faster version of `remove-duplicates'. Note you cannot specify a :TEST (it is always #'eq).
f-measureReturns the f-measure, the combination of precision and recall based on parameter beta - default ...
f-significanceThis function occurs in the statistical test of whether two observed samples have the same varian...
factorialReturns the factorial of `n,' which should be a non-negative integer. The result will returned a...
factorial-exactReturns the factorial of `n,' which should be an integer. The result will returned as an integer...
factorial-lnReturns the natural logarithm of n!; `n' should be an integer. The result will be a single-preci...
fill-2d-array
find-critical-valueReturns the critical value of some statistic. The function `p-function' should be a unary functi...
g-testCalculates the G-test for a contingency table. The formula for the G-test statistic is 2 * sum[...
gamma-incompleteThis is an incomplete gamma function, what Numerical Recipes in C calls ``gammp.'' This function ...
gamma-lnReturns the natural logarithm of the Gamma function evaluated at `x.' Mathematically, the Gamma f...
gaussian-cdfComputes the cumulative distribution function for a Gaussian random variable (defaults: mean=0.0,...
gaussian-significanceComputes the significance of `x' in a Gaussian distribution with mean=`mean' (default 0.0) and st...
inner-productReturns the inner product of the two samples, which should be sequences of numbers. The inner pr...
interquartile-rangeINTERQUARTILE-RANGE (DATA)
The interquartile range is similar to the variance of a sample because...
interquartile-range-internalSee INTERQUARTILE-RANGE
invert-matrixIf matrix is singular returns nil, else returns its inverse. If into-matrix is supplied, inver...
invert-matrix-iterateIf matrix is singular returns nil, else returns the inverse of matrix. Uses iterative improvem...
lagged-correlationReturns the correlations of `sequence1' with `sequence2' after shifting `sequence1' by `lag'. Th...
linear-regression-briefCalculates the main statistics of a linear regression: the slope and intercept of the line, the c...
linear-regression-brief-summariesCalculates the main statistics of a linear regression: the slope and intercept of the line, the c...
linear-regression-minimalCalculates the slope and intercept of the regression line. This function takes two equal-length ...
linear-regression-minimal-summariesCalculates the slope and intercept of the regression line. This function differs from `linear-re...
linear-regression-verboseCalculates almost every statistic of a linear regression: the slope and intercept of the line, th...
linear-regression-verbose-summariesCalculates almost every statistic of a linear regression: the slope and intercept of the line, th...
linear-scaleRescales value linearly from the old-min/old-max scale to the new-min/new-max one.
list-2d-array
log2Log of `n' to base 2.
make-3d-tableCollects the `dv' values for each unique combination of an element of `v1' and an element of `v2....
make-contingency-tableCounts each unique combination of an element of `v1' and an element of `v2.' Returns a two-dimens...
matrix-addition
matrix-multiplyDoes successive multiplications of each element in `args'. If two elements are scalar, then thei...
matrix-normReturns the norm of matrix. The norm is the maximum over the rows of the sum of the abs of the...
matrix-plus-matrixAdds two matrices together
matrix-plus-scalarAdd a scalar value to a matrix
matrix-times-matrixMultiplies two matrices together
matrix-times-scalarMultiply a matrix by a scalar value
matrix-times-scalar!Multiply a matrix by a scalar value
matrix-trace
maximumMAXIMUM (DATA &KEY START END KEY)
Returns the element of the sequence `data' whose `key' is maxim...
maximum-internalSee MAXIMUM
meanMEAN (DATA &KEY START END KEY)
Returns the arithmetic mean of `data,' which should be a sequence....
mean-internalSee MEAN
medianMEDIAN (DATA &KEY START END KEY)
Returns the median of the subsequence of `data' from `start' to ...
median-internalSee MEDIAN
minimumMINIMUM (DATA &KEY START END KEY)
Returns the element of the sequence `data' whose `key' is minim...
minimum-internalSee MINIMUM
mod2Find `n' mod a power of 2.
modeMODE (DATA &KEY START END KEY)
Returns the most frequent element of `data,' which should be a seq...
mode-for-continuous-dataReturns the most frequent element of `data,' which should be a sequence. The algorithm involves ...
mode-internalSee MODE
multiple-linear-regression-arraysThis is an internal function for the use of the multiple-linear-regression functions. It takes t...
multiple-linear-regression-briefLet m be the number of independent variables, `ivs.' This function returns a vector of length m w...
multiple-linear-regression-minimalLet m be the number of independent variables, `ivs.' This function returns a vector of length m ...
multiple-linear-regression-normalPerforms linear regression of the dependent variable, `dv,' on multiple independent variables, `i...
multiple-linear-regression-verboseLet m be the number of independent variables, `ivs.' This function returns fourteen values: 1. t...
multiple-modesMULTIPLE-MODES (DATA K &KEY START END KEY)
Returns the `k' most frequent elements of `data,' whic...
multiple-modes-internalSee MULTIPLE-MODES
multiply-matricesMultiply matrices MATRIX-1 and MATRIX-2, storing into MATRIX-3 if supplied. If MATRIX-3 is not su...
normalize-matrixReturns a new matrix such that the sum of its elements is 1.0
on-intervalreturns t iff x in the interval
partials-from-parents
permutation-countReturns the number of possible ways of taking k elements out of n total.
poisson-cdfComputes the cumulative distribution function for a Poisson random variable with mean `x' evaluat...
print-anova-tablePrints `anova-table' on `stream.'
print-scheffe-tablePrints `scheffe-table' on `stream.' If the original one-way anova data had N groups, the Scheffe ...
pythag-dfComputes square root of a*a + b*b without destructive overflow or underflow.
pythag-sfComputes square root of a*a + b*b without destructive overflow or underflow.
quantileQUANTILE (DATA Q &KEY START END KEY)
Returns the element which is the q'th percentile of the data...
quantile-internalSee QUANTILE
r-scoreTakes two sequences and returns the correlation coefficient. Formula: Sum (Cross-product (Differ...
radians->degreesConvert radians to degrees. Does not round the result.
rangeRANGE (DATA &KEY START END KEY)
Returns the range of the sequence `data.' Signals `no-data' if th...
range-internalSee RANGE
reduce-matrixUses the Gauss-Jordan reduction method to reduce a matrix.
remove-&restRemoves the '&rest arg' part from a lambda-list (strictly for documentation purposes.
round-to-factorEquivalent to (* factor (round n factor)). For example, `round-to-factor' of 65 and 60 is 60. U...
safe-expEliminates floating point underflow for the exponential function. Instead, it just returns 0.0d0
scalar-matrix-multiplyMultiplies a matrix by a scalar value in the form M[i,j] = s*M[i,j].
scheffe-testsPerforms all pairwise comparisons between group means, testing for significance using Scheffe's F...
significanceSIGNIFICANCE NIL
NIL
significance-internal
singular-value-decompositionReturns as three values the U W and V of singular value decomposition. If you have already conse...
skewnessSKEWNESS (DATA &KEY START END KEY)
Returns the skewness of `data', which is the sum of cubed dist...
skewness-internalSee SKEWNESS
smart-mode
smooth-4253hSmooths `data' by successive smoothing: 4,median; then 2,median; then 5,median; then 3,median; th...
smooth-hanningSmooths `data' by replacing each element with the weighted mean of it and its two neighbors. The...
smooth-mean-2With a window of size two, the median and mean smooth functions are the same.
smooth-mean-3Smooths `data' by replacing each element with the mean of it and its two neighbors. The ends are...
smooth-mean-4Smooths `data' by replacing each element with the mean of it, its left neighbor, and its two righ...
smooth-mean-5Smooths `data' by replacing each element with the median of it, its two left neighbors and its tw...
smooth-median-2Smooths `data' by replacing each element with the median of it and its neighbor on the left. A m...
smooth-median-3Smooths `data' by replacing each element with the median of it and its two neighbors. The ends a...
smooth-median-4Smooths `data' by replacing each element with the median of it, its left neighbor, and its two ri...
smooth-median-5Smooths `data' by replacing each element with the median of it, its two left neighbors and its tw...
square
standard-deviationSTANDARD-DEVIATION (DATA &KEY START END KEY)
Returns the standard deviation of `data,' which is j...
standard-deviation-internalSee STANDARD-DEVIATION
statistical-summarySTATISTICAL-SUMMARY (DATA &KEY START END KEY)
Compute the length, minimum, maximum, range, median...
statistical-summary-internalSee STATISTICAL-SUMMARY
students-t-significanceStudent's distribution is much like the Gaussian distribution except with heavier tails, dependin...
sum-listTakes a sequence of numbers and returns their sum. Formula: Sum(X).
sum-of-array-elements
sum-of-squaresReturns the sum of squared distances from the mean of `data'. Signals `no-data' if there is no d...
svbksb-dfSolves A X = B for a vector `X,' where A is specified by the mxn array U, `n' vector W, and nxn m...
svbksb-sfSolves A X = B for a vector `X,' where A is specified by the mxn array U, `n' vector W, and nxn m...
svd-back-substituteReturns the solution vector to the Ax=b, where A has been decomposed into `u,' `w' and `v' by `si...
svd-inverse-fast-dfComputes the inverse of a matrix that has been decomposed into `u,' `w' and `v' by singular value...
svd-inverse-fast-sfComputes the inverse of a matrix that has been decomposed into `u,' `w' and `v' by singular value...
svd-inverse-slow-dfComputes the inverse of a matrix that has been decomposed into `u,' `w' and `v' by singular value...
svd-inverse-slow-sfComputes the inverse of a matrix that has been decomposed into `u,' `w' and `v' by singular value...
svd-matrix-inverseUse singular value decomposition to compute the inverse of `A.' If an exact inverse is not possib...
svd-solve-linear-systemReturns solution of linear system matrix * solution = b-vector. Employs the singular value decom...
svd-zeroIf the relative magnitude of an element in `w' compared to the largest element is less than `thre...
svdcmp-dfGiven an `m'x`n' matrix `A,' this routine computes its singular value decomposition, A = U W V^T....
svdcmp-sfGiven an `m'x`n' matrix `A,' this routine computes its singular value decomposition, A = U W V^T....
svdvarGiven `v' and `w' as computed by singular value decomposition, computes the covariance matrix amo...
svzero-dfIf the relative magnitude of an element in `w' compared to the largest element is less than `thre...
svzero-sfIf the relative magnitude of an element in `w' compared to the largest element is less than `thre...
t-significanceT-SIGNIFICANCE NIL
NIL
t-significance-internal
t-testT-TEST (SAMPLE-1 SAMPLE-2 &OPTIONAL (TAILS BOTH) (H0MEAN 0))
Returns the t-statistic for the diff...
t-test-internalSee T-TEST
t-test-matchedT-TEST-MATCHED (SAMPLE1 SAMPLE2 &OPTIONAL (TAILS BOTH))
Returns the t-statistic for two matched s...
t-test-matched-internalSee T-TEST-MATCHED
t-test-one-sampleT-TEST-ONE-SAMPLE (DATA TAILS &OPTIONAL (H0-MEAN 0) &KEY START END KEY)
Returns the t-statistic f...
t-test-one-sample-internalSee T-TEST-ONE-SAMPLE
times2Multiply `i' by a power of 2.
transpose-matrix
trimmed-meanTRIMMED-MEAN (DATA PERCENTAGE &KEY START END KEY)
Returns a trimmed mean of `data.' A trimmed mea...
trimmed-mean-internalSee TRIMMED-MEAN
trunc2Truncate `n' to a power of 2.
truncate-to-factorEquivalent to (* factor (truncate n factor)). For example, `truncate-to-factor' of 65 and 60 is ...
tukey-summaryTUKEY-SUMMARY (DATA &KEY START END KEY)
Computes a Tukey five-number summary of the data. That i...
tukey-summary-internalSee TUKEY-SUMMARY
varianceVARIANCE (DATA &KEY START END KEY)
Returns the variance of `data,' that is, the `sum-of-squares' ...
variance-internalSee VARIANCE
z-test-one-sampleZ-TEST-ONE-SAMPLE (DATA TAILS &OPTIONAL (H0-MEAN 0) (H0-STD-DEV 1) &KEY START
...
z-test-one-sample-internalSee Z-TEST-ONE-SAMPLE

Generic-Function

composite-statistic-p
convert
cross-product
dot-producthttp://en.wikipedia.org/wiki/Dot_product
make-statistic
simple-statistic-p
statisticp

Macro

aref1
aref11
check-type-of-argGenerate error if the value of ARG-NAME doesn't satisfy PREDICATE. PREDICATE is a function name (...
define-statisticIn clasp, statistical objects have two parts, a class which stores the various parts of the objec...
sign-df
sign-sf
start/end
underflow-goes-to-zeroProtects against floating point underflow errors and sets the value to 0.0 instead.
with-routine-error-handling
with-temp-tableBinds `temp' to a hash table.
with-temp-vectorBinds `temp' to a vector of length at least `min-size.' It's a vector of pointers and has a fill-...