A B C D E F G H I K L M N O P Q R S T U V W X Y Z

A

abs(float[]) - Static method in class papaya.Mat
Return absolute values of an array
abs(int[]) - Static method in class papaya.Mat
Return absolute values of an array
arithmetic(float[]) - Static method in class papaya.Descriptive.Mean
Returns the arithmetic mean of a data sequence; That is Sum( data[i] ) / data.length .
arrayListToFloat(ArrayList<Float>) - Static method in class papaya.Cast
function for casting ArrayList to float[]
arrayListToInt(ArrayList<Integer>) - Static method in class papaya.Cast
function for casting ArrayList to int[]
asConnectedLines - Variable in class papaya.ScatterPlot
 
asEllipses - Variable in class papaya.ScatterPlot
 
asRectangles - Variable in class papaya.ScatterPlot
 
auto(float[], int, float, float) - Static method in class papaya.Correlation
Computes the sample autocorrelation by removing the sample mean from the input series, then normalizing the sequence by the sample variance.
autoLag1(float[], float) - Static method in class papaya.Correlation
Returns the lag-1 autocorrelation of a dataset; Note that this method uses computations different from auto(data, 1, mean, variance).

B

BASELINE - Static variable in interface papaya.PapayaConstants
 
bestFit(float[], float[]) - Static method in class papaya.Linear
Returns the slope and y-intercept of the best fit linear line z = slope*x + intercept by minimizing the sum of least squares between z and the y.
bestFit(float[], float[], float) - Static method in class papaya.Linear
Returns the slope of the best fit linear line for the prescribed y-intercept.
beta(double, double) - Static method in class papaya.Gamma
Returns the beta function of the arguments.
betacdf(double, double, double) - Static method in class papaya.Probability
Returns the area from zero to x under the beta density function.
betacdfComplemented(double, double, double) - Static method in class papaya.Probability
Returns the area under the right hand tail (from x to infinity) of the beta density function.
betainv(double, double, double) - Static method in class papaya.Probability
Returns the inverse of the beta cumulative distribution function.
bgColor - Variable in class papaya.Visuals
Specifies the plot background color
big - Static variable in interface papaya.PapayaConstants
 
biginv - Static variable in interface papaya.PapayaConstants
 
binomcdf(double, int, int) - Static method in class papaya.Probability
Returns the sum of the terms 0 through k of the Binomial probability density.
binomcdfComplemented(double, int, int) - Static method in class papaya.Probability
Returns the sum of the terms k+1 through n of the Binomial probability density.
binominv(double, int, int) - Static method in class papaya.Probability
Finds the event probability p such that the sum of the terms 0 through k of the Binomial probability density is equal to the given cumulative probability y.
BOTTOM - Static variable in interface papaya.PapayaConstants
 
bottomBound - Variable in class papaya.BoxPlot
Specifies the space on the bottom, between the plot area and the bounding rectangle.
bottomBound - Variable in class papaya.ScatterPlot
Specifies the space on the bottom, between the plot area and the bounding rectangle.
bottomBound - Variable in class papaya.SubPlot
Specifies the space on the bottom, between the plot area and the bounding rectangle.
BoxPlot - Class in papaya
BoxPlot class
BoxPlot(PApplet, float, float, float, float) - Constructor for class papaya.BoxPlot
 

C

Cast - Class in papaya
Static Class for casting Object arrays to their corresponding primitive type.
ceilToNearest(float, int) - Static method in class papaya.Mat
Function for ceiling a number to the closest interval.
CENTER - Static variable in interface papaya.PapayaConstants
 
chebychev(float[][]) - Static method in class papaya.Distance
Computes the Chebychev distance matrix between pairs of objects in the m-by-n data matrix X.
chi2(float[]) - Static method in class papaya.Normality.Dago
Computes and returns an array containing the test statistic chi2, or the "omnibus" test statistic, and the significance, or "p-value" of this test statistic.
chi2cdf(double, double) - Static method in class papaya.Probability
Returns the area under the left hand tail (from 0 to x) of the Chi square probability density function with v degrees of freedom.
chi2cdfComplemented(double, double) - Static method in class papaya.Probability
Returns the area under the right hand tail (from x to infinity) of the Chi square probability density function with v degrees of freedom.
cityblock(float[][]) - Static method in class papaya.Distance
Computes the cityblock (or Manhattan) distance matrix between pairs of objects in the m-by-n data matrix X.
classical(float[][], int, boolean) - Static method in class papaya.MDS
Performs classical (metric) multidimensional scaling, on an input matrix of Distances (computed using e.g.
column(float[][], int, int) - Static method in class papaya.Mat
Function to get columns of a 2-D matrix.
column(float[][], int) - Static method in class papaya.Mat
Function to get one column of a 2D matrix
column(int[][], int) - Static method in class papaya.Mat
 
columnMean(float[][]) - Static method in class papaya.Descriptive.Mean
Returns an array containing the arithmetic mean of each column of the input matrix.
compare(int, int) - Static method in class papaya.Mat
Returns -1 if a is less than b, or 1 if a is greater than b, or 0.
compare(float, float) - Static method in class papaya.Mat
Returns -1 if a is less than b, or 1 if a is greater than b, or 0.
Comparison - Class in papaya
Contains a number of methods for comparing more than one dataset against each other.
Comparison() - Constructor for class papaya.Comparison
Makes this class non instantiable, but still let's others inherit from it.
Comparison.TTest - Class in papaya
Methods related to comparing two populations.
compCumFrequency() - Method in class papaya.Frequency
Computes the cumulative frequency of the data.
compRelCumFrequency() - Method in class papaya.Frequency
Computes the cumulative relative frequency of the data.
compRelCumFrequencyPct() - Method in class papaya.Frequency
Computes the cumulative frequency of the data as a percentage.
compRelFrequency() - Method in class papaya.Frequency
Computes the fraction of the total data that's in each bin.
compRelFrequencyPct() - Method in class papaya.Frequency
Computes the percents of the total data that's in each bin.
concat(float[], float[]) - Static method in class papaya.Mat
Concatenates two arrays a and b into a new array c such that c = {a,b}.
concat(int[], int[]) - Static method in class papaya.Mat
 
cond() - Method in class papaya.SVD
Two norm condition number
constant(float, int) - Static method in class papaya.Mat
Returns an array with of length size with each element equal to the specified constValue.
constant(int, int) - Static method in class papaya.Mat
Returns an array with of length size with each element equal to the specified constValue.
contains(Object[], Object) - Static method in class papaya.Find
Checks if the object is in the given array.
contains(long[], long) - Static method in class papaya.Find
Checks if the value is in the given array.
contains(int[], int) - Static method in class papaya.Find
Checks if the value is in the given array.
contains(short[], short) - Static method in class papaya.Find
Checks if the value is in the given array.
contains(char[], char) - Static method in class papaya.Find
Checks if the value is in the given array.
contains(byte[], byte) - Static method in class papaya.Find
Checks if the value is in the given array.
contains(double[], double) - Static method in class papaya.Find
Checks if the value is in the given array.
contains(double[], double, double) - Static method in class papaya.Find
Checks if a value falling within the given tolerance is in the given array.
contains(float[], float) - Static method in class papaya.Find
Checks if the value is in the given array.
containsNaNs(double[]) - Static method in class papaya.NaNs
Checks for presence of NaNs in the data array.
containsNaNs(float[]) - Static method in class papaya.NaNs
Checks for presence of NaNs in the data array.
copy(float[][]) - Static method in class papaya.Mat
Make a deep copy of a matrix
copyThenSort(float[]) - Static method in class papaya.Mat
Sorts and returns a copy of the input array in ascending order
CORNER - Static variable in interface papaya.PapayaConstants
 
corr(float[][], float[], boolean) - Static method in class papaya.Correlation.Weighted
Returns the weighted linear correlation matrix C.
corr(float[], float[], float[], boolean) - Static method in class papaya.Correlation.Weighted
Returns the weighted linear correlation of two data sequences.
Correlation - Class in papaya
Contains utilities related to computing covariances, as well as linear and rank correlation.
correlation(float[][]) - Static method in class papaya.Distance
Computes the correlation distance matrix between pairs of objects in the m-by-n data matrix X.
correlation(float[], float[], float[]) - Static method in class papaya.Linear.BoxCox
Performs the box-cox transformation on y for a sequence of λ and returns the array of linear correlation coefficients between the x and the box-cox transformed y.
Correlation.Significance - Class in papaya
Contains methods used to compute the significance, or pvalue of the input correlations.
Correlation.Weighted - Class in papaya
Contains methods related to computing the correlation and covariance of weighted datasets.
CorrelationPlot - Class in papaya
Takes in a matrix and plots the data in each of the columns versus each other.
CorrelationPlot(PApplet, float, float, float, float) - Constructor for class papaya.CorrelationPlot
Setup the plot dimensions
cosine(float[][]) - Static method in class papaya.Distance
Computes the cosine distance matrix between pairs of objects in the m-by-n data matrix X.
cov(float[], float[], boolean) - Static method in class papaya.Correlation
Returns the covariance of two data sequences data1 and data2, each of length N.
cov(float[][], boolean) - Static method in class papaya.Correlation
Returns the covariance matrix of P data sequences, each of length N.
cov(float[], float[], float[], boolean) - Static method in class papaya.Correlation.Weighted
Returns the weighted covariance between two data sequences.
cov(float[][], float[], boolean) - Static method in class papaya.Correlation.Weighted
Returns the weighted covariance matrix with element S_JK specifying the weighted covariance between column J and column K of the input matrix.
cross(float[], float[]) - Static method in class papaya.Mat
vector cross product: c = a (cross) b

D

Descriptive - Class in papaya
Basic descriptive statistics class for exploratory data analysis.
Descriptive.Mean - Class in papaya
Contains methods for computing the arithmetic, geometric, harmonic, trimmed, and winsorized means (among others).
Descriptive.Pooled - Class in papaya
Class for computing the pooled mean and variance of data sequences
Descriptive.Sum - Class in papaya
Methods for computing various different sums of datasets such as sum of inversions, logs, products, power deviations, squares, etc.
Descriptive.Weighted - Class in papaya
Contains methods related to weighted datasets.
det() - Method in class papaya.LU
Determinant
det(float[][]) - Static method in class papaya.Mat
returns the determinant of the square input matrix.
dfbg() - Method in class papaya.OneWayAnova
Returns the degrees of freedom between groups.
dfwg() - Method in class papaya.OneWayAnova
Returns the degrees of freedom within each group.
Distance - Class in papaya
Contains methods for computing various "distance" metrics for multidimensional scaling.
divide(float[], float) - Static method in class papaya.Mat
Divides all elements of input array by value.
divide(float[], float[]) - Static method in class papaya.Mat
Element by element division such that z[i] = x[i]/y[i].
divide(float[][], float) - Static method in class papaya.Mat
Divides each element of the input matrix A by the input value
dotDivide(float[][], float[][]) - Static method in class papaya.Mat
Element by element matrix division such that C_ij = A_ij/B_ij.
dotMultiply(float[][], float[][]) - Static method in class papaya.Mat
Element by element matrix multiplication such that C_ij = A_ij*B_ij.
dotProduct(float[], float[]) - Static method in class papaya.Mat
dot product of two arrays such that z = sum(a_i*b_i)
doubleToFloat(double[][]) - Static method in class papaya.Cast
function for casting double[][] to float[][]
doubleToFloat(double[]) - Static method in class papaya.Cast
function for casting double[] to float[]
drawAxes - Variable in class papaya.BoxPlot
Specifies whether to draw the axes
drawAxes - Variable in class papaya.ScatterPlot
Specifies whether to draw the axes
drawAxes - Variable in class papaya.SubPlot
Specifies whether to draw the axes
drawAxes(int, float) - Method in class papaya.Visuals
Draws the plot axes using a line with color _sColor, and weight _sWeight
drawBorderAndLabels(String[], int) - Method in class papaya.CorrelationPlot
Draw the bordering lines and write the labels.
drawBoxPlot(String[], float, int) - Method in class papaya.BoxPlot
Plot the box plots.
drawPlot(float[][], int, int) - Method in class papaya.CorrelationPlot
Plots the scatter plot of each of the columns of the input data matrix vs.
drawRect() - Method in class papaya.Visuals
Draw the plot background rectangle using the default plot dimensions and background color.
drawRect(float, float, float, float, int) - Method in class papaya.Visuals
Draws the plot background rectangle using the input dimensions and background color.
drawRectangle - Variable in class papaya.BoxPlot
Specifies whether to draw the bounding rectangle around the plot.
drawRectangle - Variable in class papaya.ScatterPlot
Specifies whether to draw the bounding rectangle around the plot.
drawRectangle() - Method in class papaya.ScatterPlot
Draws a rectangle around the plot.
drawRectangle - Variable in class papaya.SubPlot
Specifies whether to draw the bounding rectangle around the plot.
drawScatterPlot(float[], float[], float, int) - Method in class papaya.ScatterPlot
Parent function to plot scatter plot of the data.
drawScatterPlot(float[], float[], int, int, int) - Method in class papaya.SubPlot
Draws the scatterplot for subplot(xnum,ynum) by calling ScatterPlot.drawScatterPlot(float[], float[], float, int).
durbinWatson(float[]) - Static method in class papaya.Correlation.Significance
The Durbin-Watson statistic is a test statistic used to detect the presence of autocorrelation (Correlation.auto(float[], int, float, float)) in the residuals (prediction errors) from a regression analysis.

E

Eigenvalue - Class in papaya
Eigenvalues and eigenvectors of a real matrix.
Eigenvalue(float[][]) - Constructor for class papaya.Eigenvalue
Check for symmetry, then construct the eigenvalue decomposition.
eliminate(double[]) - Static method in class papaya.NaNs
Eliminate the NaNs from the input array.
eliminate(float[]) - Static method in class papaya.NaNs
Eliminate the NaNs from the input array.
equalVar(float[], float[]) - Static method in class papaya.Comparison.TTest
Returns the t-statistic and p-value for checking whether the means between the two datasets are different under the assumption that both datasets have equal variances.
erf(double) - Static method in class papaya.Probability
Returns the error function of the normal distribution.
erfComplemented(double) - Static method in class papaya.Probability
Returns the complementary Error function of the normal distribution; formerly named erfc.
etasqrd() - Method in class papaya.OneWayAnova
Computes eta^2: a measure of the strength of the curvilinear relationship between the independent and dependent variable.
euclidean(float[][]) - Static method in class papaya.Distance
Computes the Euclidean distance between pairs of objects in the m-by-n data matrix X.

F

F() - Method in class papaya.OneWayAnova
Returns the test statistic F.
fcdf(double, int, int) - Static method in class papaya.Probability
Returns the area from zero to x under the F density function (also known as Snedcor's density or the variance ratio density); formerly named fdtr.
fcdfComplemented(double, int, int) - Static method in class papaya.Probability
Returns the area from x to infinity under the F density function (also known as Snedcor's density or the variance ratio density); formerly named fdtrc.
Find - Class in papaya
Static class for finding indices in an array corresponding to a given value/object.
finv(double, int, int) - Static method in class papaya.Probability
Finds the F density argument x such that the integral from 0 to x of the F density is equal to p; formerly named fdtri.
floatToDouble(float[][]) - Static method in class papaya.Cast
function for casting float[][] to double[][]
floatToDouble(float[]) - Static method in class papaya.Cast
function for casting float[] to double[]
floatToPVector(float[], float[], float[]) - Static method in class papaya.Cast
Returns a PVector array with the x, y, and z coordinates set to the input values (technically not a cast, but a reorganization).
floatToPVector(float[], float[]) - Static method in class papaya.Cast
Returns a PVector array with the x, and coordinates set to the input values, and the z coordinates set to zero.
floorToNearest(float, int) - Static method in class papaya.Mat
Function for flooring a number to the closest interval.
FONTNAME - Static variable in interface papaya.PapayaConstants
Default font used.
frequencies(float[], ArrayList<Float>, ArrayList<Integer>) - Static method in class papaya.Descriptive
Computes the frequency (number of occurances, count) of each distinct value in the given sorted data.
frequencies - Variable in class papaya.Unique
ArrayList containing the frequencies of the corresponding unique value
Frequency - Class in papaya
Class for getting the frequency distribution, cumulative frequency distribution, and other distribution-related parameters of a given array of floats or ints.
Frequency(float[], float, float, float) - Constructor for class papaya.Frequency
Initialize the class by setting the minimum value, maximum value, and the bin width.
Frequency(int[], int, int, int) - Constructor for class papaya.Frequency
Initialize the class by setting the minimum value, maximum value, and the bin width.

G

Gamma - Class in papaya
Gamma and Beta functions.
gamma(double) - Static method in class papaya.Gamma
Returns the Gamma function of the argument, Γ(x)
gammacdf(double, double, double) - Static method in class papaya.Probability
Returns the integral from zero to x of the gamma probability density function.
gammacdfComplemented(double, double, double) - Static method in class papaya.Probability
Returns the integral from x to infinity of the gamma probability density function:
geometric(int, float) - Static method in class papaya.Descriptive.Mean
Returns the geometric mean of a data sequence.
geometric(float[]) - Static method in class papaya.Descriptive.Mean
Returns the geometric mean of a data sequence.
getBottom() - Method in class papaya.Visuals
 
getD() - Method in class papaya.Eigenvalue
Return the block diagonal eigenvalue matrix
getData() - Method in class papaya.BoxPlot
 
getFloatPivot() - Method in class papaya.LU
Return pivot permutation vector as a one-dimensional float array
getFrequency() - Method in class papaya.Frequency
Returns the pre-computed frequency array.
getH() - Method in class papaya.QR
Return the Householder vectors
getHeight() - Method in class papaya.Visuals
 
getImagEigenvalues() - Method in class papaya.Eigenvalue
Return the imaginary parts of the eigenvalues
getL() - Method in class papaya.LU
Return lower triangular factor, L.
getLeft() - Method in class papaya.Visuals
 
getLength() - Method in class papaya.Frequency
returns the length of the dataset.
getNaNPositions(double[]) - Static method in class papaya.NaNs
Returns an array list of indexes where data[i] is NaN.
getNaNPositions(float[]) - Static method in class papaya.NaNs
Returns an array list of indexes where data[i] is NaN.
getNumBins() - Method in class papaya.Frequency
Returns the number of bins.
getPivot() - Method in class papaya.LU
Return pivot permutation vector
getQ() - Method in class papaya.QR
Generate and return the (economy-sized) orthogonal factor
getR() - Method in class papaya.QR
Return the upper triangular factor
getRealEigenvalues() - Method in class papaya.Eigenvalue
Return the real parts of the eigenvalues
getRight() - Method in class papaya.Visuals
 
getS() - Method in class papaya.SVD
Return the diagonal matrix of singular values
getSingularValues() - Method in class papaya.SVD
Return the one-dimensional array of singular values
getTop() - Method in class papaya.Visuals
 
getU() - Method in class papaya.LU
Return upper triangular factor, U
getU() - Method in class papaya.SVD
Return the left singular vectors
getV() - Method in class papaya.Eigenvalue
Return the eigenvector matrix with each column corresponding to an eigenvector of the input matrix.
getV() - Method in class papaya.SVD
Return the right singular vectors
getWidth() - Method in class papaya.Visuals
 
GRAY - Static variable in interface papaya.PapayaConstants
 

H

harmonic(int, float) - Static method in class papaya.Descriptive.Mean
Returns the harmonic mean of a data sequence.
harmonic(float[]) - Static method in class papaya.Descriptive.Mean
Returns the harmonic mean of a data sequence as Sum( 1.0 / data[i]).
horizLine(float, float, float, int, float) - Method in class papaya.Visuals
draws a horizonal line with color _sColor, and weight _sWeight

I

identity(int) - Static method in class papaya.Mat
returns the identity matrix of the specified dimension
idx - Variable in class papaya.Unique
Class containing the integer arrays that hold the indices of each unique value.
incompleteBeta(double, double, double) - Static method in class papaya.Gamma
Returns the Incomplete Beta Function evaluated from zero to xx; formerly named ibeta.
incompleteBetaInverse(double, double, double) - Static method in class papaya.Gamma
Returns the inverse of the incomplete Beta integral.
incompleteGamma(double, double) - Static method in class papaya.Gamma
Returns the Incomplete Gamma function; formerly named igamma.
incompleteGammaComplement(double, double) - Static method in class papaya.Gamma
Returns the Complemented Incomplete Gamma function; formerly named igamc.
INDEX_NOT_FOUND - Static variable in interface papaya.PapayaConstants
Index to return if a given value/object is not found in the Cast function.
indexOf(Object[], Object) - Static method in class papaya.Find
Finds the index of the given object in the array.
indexOf(Object[], Object, int) - Static method in class papaya.Find
Finds the index of the given object in the array starting at the given index.
indexOf(long[], long) - Static method in class papaya.Find
Finds the index of the given value in the array.
indexOf(long[], long, int) - Static method in class papaya.Find
Finds the index of the given value in the array starting at the given index.
indexOf(int[], int) - Static method in class papaya.Find
Finds the index of the given value in the array.
indexOf(int[], int, int) - Static method in class papaya.Find
Finds the index of the given value in the array starting at the given index.
indexOf(short[], short) - Static method in class papaya.Find
Finds the index of the given value in the array.
indexOf(short[], short, int) - Static method in class papaya.Find
Finds the index of the given value in the array starting at the given index.
indexOf(char[], char) - Static method in class papaya.Find
Finds the index of the given value in the array.
indexOf(char[], char, int) - Static method in class papaya.Find
Finds the index of the given value in the array starting at the given index.
indexOf(byte[], byte) - Static method in class papaya.Find
Finds the index of the given value in the array.
indexOf(byte[], byte, int) - Static method in class papaya.Find
Finds the index of the given value in the array starting at the given index.
indexOf(double[], double) - Static method in class papaya.Find
Finds the index of the given value in the array.
indexOf(double[], double, double) - Static method in class papaya.Find
Finds the index of the given value within a given tolerance in the array.
indexOf(double[], double, int) - Static method in class papaya.Find
Finds the index of the given value in the array starting at the given index.
indexOf(double[], double, int, double) - Static method in class papaya.Find
Finds the index of the given value in the array starting at the given index.
indexOf(float[], float) - Static method in class papaya.Find
Finds the index of the given value in the array.
indexOf(float[], float, int) - Static method in class papaya.Find
Finds the index of the given value in the array starting at the given index.
indexOf(boolean[], boolean) - Static method in class papaya.Find
Finds the index of the given value in the array.
indexOf(boolean[], boolean, int) - Static method in class papaya.Find
Finds the index of the given value in the array starting at the given index.
indices(float[], boolean) - Static method in class papaya.Sorting
Gets the array of indices that can be used to sort the array in ascending or descending order.
indices(double[], boolean) - Static method in class papaya.Sorting
 
indices(int[], boolean) - Static method in class papaya.Sorting
 
indices(float[], int, int, boolean) - Static method in class papaya.Sorting
Gets the array of indices that can be used to sort the section of the input array going from fromIndex(inclusive) to toIndex(exclusive) in ascending or descending order.
indices(double[], int, int, boolean) - Static method in class papaya.Sorting
 
indices(int[], int, int, boolean) - Static method in class papaya.Sorting
 
INDICES_NOT_FOUND - Static variable in interface papaya.PapayaConstants
Index array to return if a given value/object is not found in the Cast function.
indicesGreaterThan(int[], int) - Static method in class papaya.Find
 
indicesGreaterThan(float[], float) - Static method in class papaya.Find
 
indicesGreaterThanOrEqualTo(int[], int) - Static method in class papaya.Find
 
indicesGreaterThanOrEqualTo(float[], float) - Static method in class papaya.Find
 
indicesLessThan(int[], int) - Static method in class papaya.Find
 
indicesLessThan(float[], float) - Static method in class papaya.Find
 
indicesLessThanOrEqualTo(int[], int) - Static method in class papaya.Find
 
indicesLessThanOrEqualTo(float[], float) - Static method in class papaya.Find
 
indicesWith(Object[], Object) - Static method in class papaya.Find
Finds the indices containing the specified object in the array.
indicesWith(Object[], Object, int) - Static method in class papaya.Find
Finds the indices containing the specified object in the array.
indicesWith(long[], long) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(long[], long, int) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(int[], int) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(int[], int, int) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(short[], short) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(short[], short, int) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(char[], char) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(char[], char, int) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(byte[], byte) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(byte[], byte, int) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(double[], double) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(double[], double, int) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(float[], float) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(float[], float, int) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(boolean[], boolean) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWith(boolean[], boolean, int) - Static method in class papaya.Find
Finds the indices containing the specified value in the array.
indicesWithin(int[], float, float) - Static method in class papaya.Find
Finds the indices for the array elements within the min and max value (inclusive).
indicesWithin(float[], float, float) - Static method in class papaya.Find
Finds the indices for the array elements within the min and max value (inclusive).
intercept(float, float, int) - Static method in class papaya.Linear.Significance
Returns the p-value, or significance, of the computed intercept under the null-hypothesis of intercept = 0 (two-tailed test).
intercept(float[], float) - Static method in class papaya.Linear.StdErr
Returns the standard error of the computed slope given x and the standard error in the residuals.
inverse(float[], float) - Static method in class papaya.Mat
Returns the array z[i] = 1/x[i]; If x[i] is zero, it sets z[i] to the specified replaceZeroWith value instead.
inverse(float[][]) - Static method in class papaya.Mat
Matrix inverse if A is square, pseudoinverse otherwise
inversions(float[], int, int) - Static method in class papaya.Descriptive.Sum
Returns the sum of inversions of a data sequence, which is Sum( 1.0 / data[i]).
isConstant(float[]) - Static method in class papaya.Mat
 
isFullRank() - Method in class papaya.QR
Is the matrix full rank?
isNonsingular() - Method in class papaya.LU
Is the matrix nonsingular?

K

keySetToFloat(HashMap) - Static method in class papaya.Cast
Function for casting hashMap keySet to float[]
keySetToInt(HashMap) - Static method in class papaya.Cast
Function for casting hashMap keySet to float[]
keySetToString(HashMap) - Static method in class papaya.Cast
Function for casting hashMap keySet to String[]
kurtosis(float, float) - Static method in class papaya.Descriptive
Returns the kurtosis (aka excess) of a data sequence.
kurtosis(float[], float, float) - Static method in class papaya.Descriptive
Returns the kurtosis (aka excess) of a data sequence, which is -3 + moment(data,4,mean) / standardDeviation4.
kurtosis(float[]) - Static method in class papaya.Normality.Dago
Computes and returns an array containing the test statistic zb2associated with b2 and the significance, or "p-value" of the kurtosis test statistic zb2, assuming a two-tailed null hypothesis as well as .

L

lastIndexOf(Object[], Object) - Static method in class papaya.Find
Finds the last index of the given object within the array.
lastIndexOf(Object[], Object, int) - Static method in class papaya.Find
Finds the last index of the given object in the array starting at the given index.
lastIndexOf(long[], long) - Static method in class papaya.Find
Finds the last index of the given value within the array.
lastIndexOf(long[], long, int) - Static method in class papaya.Find
Finds the last index of the given value in the array starting at the given index.
lastIndexOf(int[], int) - Static method in class papaya.Find
Finds the last index of the given value within the array.
lastIndexOf(int[], int, int) - Static method in class papaya.Find
Finds the last index of the given value in the array starting at the given index.
lastIndexOf(short[], short) - Static method in class papaya.Find
Finds the last index of the given value within the array.
lastIndexOf(short[], short, int) - Static method in class papaya.Find
Finds the last index of the given value in the array starting at the given index.
lastIndexOf(char[], char) - Static method in class papaya.Find
Finds the last index of the given value within the array.
lastIndexOf(char[], char, int) - Static method in class papaya.Find
Finds the last index of the given value in the array starting at the given index.
lastIndexOf(byte[], byte) - Static method in class papaya.Find
Finds the last index of the given value within the array.
lastIndexOf(byte[], byte, int) - Static method in class papaya.Find
Finds the last index of the given value in the array starting at the given index.
lastIndexOf(double[], double) - Static method in class papaya.Find
Finds the last index of the given value within the array.
lastIndexOf(double[], double, double) - Static method in class papaya.Find
Finds the last index of the given value within a given tolerance in the array.
lastIndexOf(double[], double, int) - Static method in class papaya.Find
Finds the last index of the given value in the array starting at the given index.
lastIndexOf(double[], double, int, double) - Static method in class papaya.Find
Finds the last index of the given value in the array starting at the given index.
lastIndexOf(float[], float) - Static method in class papaya.Find
Finds the last index of the given value within the array.
lastIndexOf(float[], float, int) - Static method in class papaya.Find
Finds the last index of the given value in the array starting at the given index.
lastIndexOf(boolean[], boolean) - Static method in class papaya.Find
Finds the last index of the given value within the array.
lastIndexOf(boolean[], boolean, int) - Static method in class papaya.Find
Finds the last index of the given value in the array starting at the given index.
LEFT - Static variable in interface papaya.PapayaConstants
 
leftBound - Variable in class papaya.BoxPlot
Specifies the space on the left between the plot area, and the bounding rectangle.
leftBound - Variable in class papaya.ScatterPlot
Specifies the space on the left between the plot area, and the bounding rectangle.
leftBound - Variable in class papaya.SubPlot
Specifies the space on the left between the plot area, and the bounding rectangle.
legendHoriz(String, int[], String[]) - Method in class papaya.SubPlot
Draws a legend going to the right with the first element situated at (x,y).
legendHoriz(float, float, int[], String[]) - Method in class papaya.Visuals
Draws a legend going to the right with the first element situated at (x,y).
legendVert(float, float, int[], String[]) - Method in class papaya.SubPlot
Draws a legend going downwards with the first element situated at (x,y).
legendVert(float, float, int[], String[]) - Method in class papaya.Visuals
Draws a legend going downwards with the first element situated at (x,y).
line(float, float, float, float, int, float) - Method in class papaya.Visuals
Draws a straight line going from (x[0],y[0]) to (x[1],y[1]) with color _sColor, and weight _sWeight
linear(float[][], boolean) - Static method in class papaya.Correlation
Returns the (Pearson Product Moment) correlation matrix between multiple columns of a matrix with each column corresponding to a dataset, and each row an observation.
linear(float[], float[], boolean) - Static method in class papaya.Correlation
Returns the (Pearson Product Moment) linear correlation of two data sequences.
linear(float, int) - Static method in class papaya.Correlation.Significance
Returns the p-value, or significance level of the linear correlation r between two datasets under the null hypothesis of no correlation.
Linear - Class in papaya
Contains methods related to determining the linear linear relationship between two datasets (of equal arrays) such as the best-fit linear line parameters, box-cox transformations, etc.
Linear() - Constructor for class papaya.Linear
 
Linear.BoxCox - Class in papaya
Contains methods related to the Box-Cox transformation of a data set; useful in determining the best transformation that will yield the best method for converting a monotonic, non-linear relationship between x and y into a linear one.
Linear.Significance - Class in papaya
Contains methods used to compute the significance, or pvalue of the input correlations.
Linear.Significance() - Constructor for class papaya.Linear.Significance
 
Linear.StdErr - Class in papaya
Contains methods related to computing the standard errors of the residuals, slope and intercept associated with the best-fit linear line.
linspace(int, int) - Static method in class papaya.Mat
Returns the array of (end-start+1) points going from start (inclusive) to end (inclusive): y[0] = start; y[1] = start+1; ...
linspace(int, int, int) - Static method in class papaya.Mat
 
linspace(float, float, float) - Static method in class papaya.Mat
 
log(float[]) - Static method in class papaya.Mat
Returns an array with each element equal to the natural logarithm (the base-e logarithm) the corresponding input array.
log10(float[]) - Static method in class papaya.Mat
Returns an array with each element equal to the log 10 value (base 10 logarithm) of the corresponding input array.
logGamma(double) - Static method in class papaya.Gamma
Returns the natural logarithm of the gamma function; formerly named lgamma.
LOGPI - Static variable in interface papaya.PapayaConstants
 
logs(float[], int, int) - Static method in class papaya.Descriptive.Sum
Returns the sum of logarithms of a data sequence, which is Sum( Log(data[i]).
logToBase(float[], float) - Static method in class papaya.Mat
Returns an array with each element equal to the log A value of the corresponding input array.
LU - Class in papaya
LU Decomposition.
LU(float[][]) - Constructor for class papaya.LU
Constructor.

M

MACHEP - Static variable in interface papaya.PapayaConstants
machine constants
mag(float[]) - Static method in class papaya.Mat
Returns the magnitude of the input array = sqrt(x1^2 + x2^2 + ...
mahalanobis(float[][]) - Static method in class papaya.Distance
Computes the Mahalanobis distance matrix of the m-by-n input matrix X.
mannWhitney(float[], float[]) - Static method in class papaya.Comparison
Computes and returns the MannWhitney (or Wilcoxon Rank Sum) test statistic, U and p-value for assessing whether one of two samples of independent observations tends to have larger values than the other.
map(float, float, float, float, float) - Static method in class papaya.Mat
Convenience function to map a variable from one coordinate space to another.
map(float[], float, float) - Static method in class papaya.Mat
Similar to map([] value, valueArrayMinimum, valueArrayMaximum, from, to)
map(float[], float, float, float, float) - Static method in class papaya.Mat
Function for mapping an input array of floats for plotting Extends processing "map" function to accomodate arrays.
mapXData(float[]) - Method in class papaya.Visuals
Maps the x-data from the range min(data) to max(data) to the plotLeft and plotLeft+plotWidth.
mapXData(float[], float, float) - Method in class papaya.Visuals
Maps the x-data from the range minXDat to maxXDat to the plotLeft and plotRight.
mapYData(float[]) - Method in class papaya.Visuals
Maps the y-data from the range min(data) to max(data) to the plotBottom and plotTop.
mapYData(float[], float, float) - Method in class papaya.Visuals
Maps the y-data from the range minYDat to maxYDat to the plotBottom and plotTop.
Mat - Class in papaya
Static class for performing some basic matrix operations.
max(int, int) - Static method in class papaya.Descriptive
 
max(float, float) - Static method in class papaya.Descriptive
 
max(double, double) - Static method in class papaya.Descriptive
 
max(double[]) - Static method in class papaya.Descriptive
Returns the largest member of a data sequence.
max(float[]) - Static method in class papaya.Descriptive
Returns the largest member of a data sequence.
max(int[]) - Static method in class papaya.Descriptive
Returns the largest member of a data sequence.
max(float[][]) - Static method in class papaya.Descriptive
Returns the largest member of a matrix.
max(int[][]) - Static method in class papaya.Descriptive
Returns the largest member of a matrix.
MAXGAM - Static variable in interface papaya.PapayaConstants
 
MAXLOG - Static variable in interface papaya.PapayaConstants
 
MDS - Class in papaya
Contains methods for performing but classical and non-classical multidimensional scaling.
mean(float[]) - Static method in class papaya.Descriptive
Returns the arithmetic mean of a data sequence; That is Sum( data[i] ) / data.length .
mean(float, int, float, int) - Static method in class papaya.Descriptive.Pooled
Returns the pooled mean of two data sequences.
mean(float[], int[]) - Static method in class papaya.Descriptive.Pooled
Returns the pooled mean of a k data sequences.
mean(float[], float[]) - Static method in class papaya.Descriptive.Weighted
Returns the weighted mean of a data sequence.
meanDeviation(float[], float) - Static method in class papaya.Descriptive
Returns the mean deviation of a dataset.
median(float[], boolean) - Static method in class papaya.Descriptive
Returns the median of a data sequence.
min(int, int) - Static method in class papaya.Descriptive
 
min(float, float) - Static method in class papaya.Descriptive
 
min(double, double) - Static method in class papaya.Descriptive
 
min(double[]) - Static method in class papaya.Descriptive
Returns the smallest member of a data sequence.
min(float[]) - Static method in class papaya.Descriptive
Returns the smallest member of a data sequence.
min(float[][]) - Static method in class papaya.Descriptive
Returns the smallest member of a matrix.
min(int[]) - Static method in class papaya.Descriptive
Returns the smallest member of a data sequence.
min(int[][]) - Static method in class papaya.Descriptive
Returns the smallest member of a matrix.
minkowski(float[][], int) - Static method in class papaya.Distance
Returns the Minkowski distance matrix of the m-by-n input matrix X.
MINLOG - Static variable in interface papaya.PapayaConstants
 
mod(float[]) - Static method in class papaya.Descriptive
Returns the array containing the elements that appear the most in a given dataset.
moment(float[], int, float) - Static method in class papaya.Descriptive
Returns the moment of k-th order with constant c of a data sequence, which is Sum( (data[i]-c)k ) / data.size().
multiply(float[][], float[][]) - Static method in class papaya.Mat
Multiplies two matrices A and B returning C = A*B where C_ij = Sum(k=1 to n) A_ik*B_kj.
multiply(float[][], float[]) - Static method in class papaya.Mat
Multiplies the matrix A with the vector x returning A*x = y where y_j= Sum(k=j to n) A_ij*x_j.
multiply(float[][], float) - Static method in class papaya.Mat
Multiplies the matrix A with the scalar a returning a*A = B where B_ij = a*A_ij.
multiply(float[], float[]) - Static method in class papaya.Mat
Multiplies two arrays and returns the multiplied array.
multiply(float[], float) - Static method in class papaya.Mat
Multiplies each element of an array by a number, and returns the multiplied array.

N

NaNs - Class in papaya
Contains various methods for dealing with NaNs in your data.
nbinomcdf(double, int, int) - Static method in class papaya.Probability
Returns the sum of the terms 0 through k of the Negative Binomial Distribution.
nbinomcdfComplemented(double, int, int) - Static method in class papaya.Probability
Returns the sum of the terms k+1 to infinity of the Negative Binomial distribution.
norm1(float[][]) - Static method in class papaya.Mat
Returns the norm1 of the input matrix, equal to the maximum absolute column sum of the matrix.
norm2(float[][]) - Static method in class papaya.Mat
Returns the norm2 (or maximum singular value) of the input matrix.
norm2(float[]) - Static method in class papaya.Mat
Returns the norm2 or magnitude of an array.
norm2() - Method in class papaya.SVD
Two norm
Normality - Class in papaya
Contains various utilities for checking if the dataset comes from a normal distribution.
Normality.Dago - Class in papaya
Methods for computing the skewnewss, kurtosis, and D'Agostino-Peasrson K^2 "omnibus" test-statistics (that combine the former two), and accompanying significance (or p-values) for testing the underlying population normality.
normalizeToMinMax(float[]) - Static method in class papaya.Mat
Returns an array with elements consisting of the data normalized to the specified min/max; new data goes from 0 to 1.
normalizeToSum(float[]) - Static method in class papaya.Mat
Returns an array with elements given by z[i] = data[i] / sum(data);
normalProbability(float[]) - Static method in class papaya.Normality
Return the Normal order statistic medians (N) necessary to produce a Q-Q plot for a normal distribution (or normal probability plot).
normcdf(double) - Static method in class papaya.Probability
Returns the area under the Normal (Gaussian) probability density function, integrated from minus infinity to x (assumes mean is zero, variance is one).
normcdf(double, double, double) - Static method in class papaya.Probability
Returns the area under the Normal (Gaussian) probability density function, integrated from minus infinity to x when the data has not been standardized (i.e.
normF(float[][]) - Static method in class papaya.Mat
/** Returns the Frobenius norm of the input matrix; sqrt of sum of squares of all elements.
normInf(float[][]) - Static method in class papaya.Mat
Returns the Infinity norm of the input matrix, equal to the maximum row sum.
norminv(double) - Static method in class papaya.Probability
Returns the value, x, for which the area under the Normal (Gaussian) probability density function (integrated from minus infinity to x) is equal to the argument y (assumes mean is zero, variance is one); formerly named ndtri.
numGreaterThan(int[], int) - Static method in class papaya.Find
Finds the number of elements strictly greater than the specified value.
numGreaterThan(float[], float) - Static method in class papaya.Find
Finds the number of elements strictly greater than the specified value.
numGreaterThanOrEqualTo(int[], int) - Static method in class papaya.Find
Finds the number of elements greater than or equal to the specified value.
numGreaterThanOrEqualTo(float[], float) - Static method in class papaya.Find
Finds the number of elements greater than or equal to the specified value.
numLessThan(int[], int) - Static method in class papaya.Find
Finds the number of elements strictly less than the specified value.
numLessThan(float[], float) - Static method in class papaya.Find
Finds the number of elements strictly less than the specified value.
numLessThanOrEqualTo(int[], int) - Static method in class papaya.Find
Finds the number of elements less than or equal to the specified value.
numLessThanOrEqualTo(float[], float) - Static method in class papaya.Find
Finds the number of elements less than or equal to the specified value.
numRepeats(Object[], Object) - Static method in class papaya.Find
Finds the number of times a given value/object is present in an array.
numRepeats(long[], long) - Static method in class papaya.Find
Finds the number of times a given value/object is present in an array.
numRepeats(int[], int) - Static method in class papaya.Find
Finds the number of times a given value/object is present in an array.
numRepeats(short[], short) - Static method in class papaya.Find
Finds the number of times a given value/object is present in an array.
numRepeats(char[], char) - Static method in class papaya.Find
Finds the number of times a given value/object is present in an array.
numRepeats(byte[], byte) - Static method in class papaya.Find
Finds the number of times a given value/object is present in an array.
numRepeats(double[], double) - Static method in class papaya.Find
Finds the number of times a given value/object is present in an array.
numRepeats(float[], float) - Static method in class papaya.Find
Finds the number of times a given value/object is present in an array.
numRepeats(boolean[], boolean) - Static method in class papaya.Find
Finds the number of times a given value/object is present in an array.

O

OneWayAnova - Class in papaya
Computes the one-way ANOVA p-value to test the equality of two or more sample means by analyzing the sample variances using the test statistic F = variance between samples / variance within samples.
OneWayAnova(Collection<float[]>) - Constructor for class papaya.OneWayAnova
Performs an Analysis of Variance (ANOVA) for a collection of float arrays.
outliers(float[], float, float, boolean) - Static method in class papaya.Descriptive
Returns the array containing all elements in the dataset that are less than or equal to the lowerLimit and more than or equal to the upperLimit

P

paired(float[], float[]) - Static method in class papaya.Comparison.TTest
Returns the t-statistic and p-value for checking a pair of dependent samples.
papaya - package papaya
 
PapayaConstants - Interface in papaya
PapayaConstants stores some of the constants used in plotting.
poissoncdf(double, int) - Static method in class papaya.Probability
Returns the sum of the first k terms of the Poisson distribution.
poissoncdfComplemented(int, double) - Static method in class papaya.Probability
Returns the sum of the terms k+1 to Infinity of the Poisson distribution.
Polynomial - Class in papaya
Static Class for casting one variable type to another.
polyval(double, double[]) - Static method in class papaya.Polynomial
y = polyval(x,coeff) returns the value of a polynomial of degree n evaluated at x.
polyval(double[], double[]) - Static method in class papaya.Polynomial
y = polyval(x,coeff) returns the array values of a polynomial of degree n evaluated at each element of x.
polyval(float, float[]) - Static method in class papaya.Polynomial
y = polyval(x,coeff) returns the value of a polynomial of degree n evaluated at x.
polyval(float[], float[]) - Static method in class papaya.Polynomial
y = polyval(x,coeff) returns the value of a polynomial of degree n evaluated at x.
populate(double[], int[]) - Static method in class papaya.Mat
Returns an array with each element corresponding to fullDataset[indices[i]].
populate(float[], int[]) - Static method in class papaya.Mat
Returns an array with each element corresponding to fullDataset[indices[i]].
populate(int[], int[]) - Static method in class papaya.Mat
Returns an array with each element corresponding to fullDataset[indices[i]].
populate(String[], int[]) - Static method in class papaya.Mat
Returns an array with each element corresponding to fullDataset[indices[i]].
powerDeviations(float[], int, float) - Static method in class papaya.Descriptive.Sum
Returns Sum( (data[i]-c)k ); optimized for common parameters like c == 0.0 and/or k == -2 ..
powerDeviations(float[], int, float, int, int) - Static method in class papaya.Descriptive.Sum
Returns Sum( (data[i]-c)k ) for all i = from ..
powers(float[], int) - Static method in class papaya.Descriptive.Sum
Returns the sum of powers of a data sequence, which is Sum ( data[i]k ).
print(double[], int) - Static method in class papaya.Mat
Print the array to the screen in a single line.
print(double[][], int) - Static method in class papaya.Mat
Print the matrix to the screen with each row of the matrix taking up one line.
print(double[][], String[], String[], int) - Static method in class papaya.Mat
Print the matrix to the screen with the columns and rows labeled according to the input strings.
print(float[], int) - Static method in class papaya.Mat
Print the array to the screen in a single line.
print(float[][], int) - Static method in class papaya.Mat
Print the matrix to the screen with each row of the matrix taking up one line.
print(float[][], String[], String[], int) - Static method in class papaya.Mat
Print the matrix to the screen with the columns and rows labeled according to the input strings.
print(int[], int) - Static method in class papaya.Mat
Print the array to the screen in a single line.
print(int[][], int) - Static method in class papaya.Mat
Print the matrix to the screen with each row of the matrix taking up one line.
print(int[][], String[], String[], int) - Static method in class papaya.Mat
Print the matrix to the screen with the columns and rows labeled according to the input strings.
Probability - Class in papaya
Cumulative distribution functions and corresponding inverses of certain probability distributions.
product(int, float) - Static method in class papaya.Descriptive
Returns the product, which is Prod( data[i] ).
product(float[]) - Static method in class papaya.Descriptive
Returns the product of a data sequence, which is Prod( data[i] ).
products(float[], float[]) - Static method in class papaya.Descriptive.Sum
Returns the sum of the product of two data arrays, Sum( x[i] * y[i]).
pValue() - Method in class papaya.OneWayAnova
Returns the significance, or "p-value" of the test statistic OneWayAnova.F().
pValues(float[]) - Static method in class papaya.Normality.Dago
Returns an array containing the three significance, or p-values, for testing normality.

Q

QR - Class in papaya
QR Decomposition.
QR(float[][]) - Constructor for class papaya.QR
QR Decomposition, computed by Householder reflections.
quantile(float[], float) - Static method in class papaya.Descriptive
Returns the phi-quantile; that is, an element elem for which holds that phi percent of data elements are less than elem.
quantileInverse(float[], float) - Static method in class papaya.Descriptive
Returns how many percent of the elements contained in the receiver are <= element.
quantiles(float[], float[]) - Static method in class papaya.Descriptive
Returns the quantiles of the specified percentages.
quartiles(float[], boolean) - Static method in class papaya.Descriptive
Returns the quartiles of the input data array (not necessarily sorted).

R

rank(float[][]) - Static method in class papaya.Mat
Returns the effective numerical rank (obtained from SVD) of the input matrix.
Rank - Class in papaya
Ranking based on the natural ordering on floats for a sequence of data that may also contain NaNs.
rank(int[], int, int) - Static method in class papaya.Rank
Rank an array containing NaN values using the natural ordering on Floats, with NaN values handled according to nanStrategy and ties resolved using tiesStrategy.
rank(float[], int, int) - Static method in class papaya.Rank
Rank an array containing NaN values using the natural ordering on Floats, with NaN values handled according to nanStrategy and ties resolved using tiesStrategy.
rank(int[], int) - Static method in class papaya.Rank
Rank an array (with no NaNs) using the natural ordering on Floats with ties resolved using tiesStrategy.
rank(float[], int) - Static method in class papaya.Rank
Rank an array (with no NaNs) using the natural ordering on Floats with ties resolved using tiesStrategy.
rank() - Method in class papaya.SVD
Effective numerical matrix rank
rankInterpolated(float[], float) - Static method in class papaya.Descriptive
Returns the linearly interpolated number of elements in an array that are ≤ a given element.
replace(float[][], float, float) - Static method in class papaya.Mat
Returns a new matrix B equal to A, except that all elements in A which are equal to oldValue with the newValue.
replace(float[], float, float) - Static method in class papaya.Mat
Returns a new array data2 which is similar to data, except that all elements in data which are equal to oldValue are replaced with the newValue.
replaceNewWith(double[], double) - Static method in class papaya.NaNs
Returns a new array with NaN elements in the original data set replaced with the value specified by newNaN.
replaceNewWith(float[], float) - Static method in class papaya.NaNs
Returns a new array with NaN elements in the original data set replaced with the value specified by newNaN.
replaceOriginalWith(double[], double) - Static method in class papaya.NaNs
Modifies the original data array by replacing the NaN elements in the data set with the value specified by newNaN.
replaceOriginalWith(float[], float) - Static method in class papaya.NaNs
Modifies the original data array by replacing the NaN elements in the data set with the value specified by newNaN.
reshape(float[][], int, int) - Static method in class papaya.Mat
Reshapes a matrix into the new specified dimensions.
residual(float[], int) - Static method in class papaya.Linear.StdErr
Returns the standard error of the residuals given the degrees of freedom.
residuals(float[], float[], float, float) - Static method in class papaya.Linear
Compute and return the array of residuals given by Delta_i = z_i - y_i, where z_i = (slope*x_i + intercept) is the best fit linear line.
residuals(float[], float[]) - Static method in class papaya.Linear
Compute and return the array of residuals given by Delta_i = z_i - y_i, where z_i = (slope*x_i + intercept) is the best fit linear line.
reverse(double[]) - Static method in class papaya.Mat
reverses the order of the elements in an array.
reverse(float[]) - Static method in class papaya.Mat
reverses the order of the elements in an array.
reverse(int[]) - Static method in class papaya.Mat
reverses the order of the elements in an array.
RIGHT - Static variable in interface papaya.PapayaConstants
 
rightBound - Variable in class papaya.BoxPlot
Specifies the space on the right betweent the plot area, and the bounding rectangle.
rightBound - Variable in class papaya.ScatterPlot
Specifies the space on the right betweent the plot area, and the bounding rectangle.
rightBound - Variable in class papaya.SubPlot
Specifies the space on the right betweent the plot area, and the bounding rectangle.
rms(int, double) - Static method in class papaya.Descriptive
Returns the RMS (Root-Mean-Square) of a data sequence.
rms(float, float) - Static method in class papaya.Descriptive.Weighted
Returns the weighted RMS (Root-Mean-Square) of a data sequence.
roundToDecimalPlace(float, int) - Static method in class papaya.Mat
Function for rounding to a given decimal place.
rowMean(float[][]) - Static method in class papaya.Descriptive.Mean
Returns an array containing the arithmetic mean of each row of the input matrix.

S

s - Variable in class papaya.SubPlot
 
ScatterPlot - Class in papaya
A simple class to plot x vs y data as a scatter plot.
ScatterPlot(PApplet, float, float, float, float) - Constructor for class papaya.ScatterPlot
 
setBackgroundColor(int) - Method in class papaya.Visuals
 
setData(float[][], float, float) - Method in class papaya.BoxPlot
Sets the data to be plotted.
setDataExtremes(float, float, float, float) - Method in class papaya.ScatterPlot
Set the minimum/maximum values on the x and y axis to nice numbers.
setDataExtremes(float, float, float, float, int, int) - Method in class papaya.SubPlot
Sets the data extremes for subplot(xnum,ynum) by calling ScatterPlot.setDataExtremes(float, float, float, float)
setHeight(float) - Method in class papaya.Visuals
 
setLeft(float) - Method in class papaya.Visuals
 
setToFloat(Set<Float>) - Static method in class papaya.Cast
Function for casting a Set to float[]
setToInt(Set<Integer>) - Static method in class papaya.Cast
Function for casting a Set to float[]
setTop(float) - Method in class papaya.Visuals
 
setToString(Set<String>) - Static method in class papaya.Cast
Function for casting a Set to String array.
setupFont(String, int, int, int) - Method in class papaya.Visuals
function for setting the font up for writing the labels
setupFont(String, int, int, int, int) - Method in class papaya.Visuals
overload setupFont function that takes in font color
setWidth(float) - Method in class papaya.Visuals
 
seuclidean(float[][]) - Static method in class papaya.Distance
Computes the standardized Euclidean distance between pairs of objects in the m-by-n data matrix X by standardizing X first prior to computing the distances.
signTest(float[], float[]) - Static method in class papaya.Comparison
Performs the sign test on an input array and returns the test statistic used to test the hypothesis that there is "no difference in medians" between the continuous distributions of two random variables X and Y.
skew(float, float) - Static method in class papaya.Descriptive
Returns the skew of a data sequence when the 3rd moment has already been computed.
skew(float[], float, float) - Static method in class papaya.Descriptive
Returns the skew of a data sequence, which is moment(data,3,mean) / standardDeviation3.
skew(float[]) - Static method in class papaya.Normality.Dago
Computes and returns an array containing the test statistic zb1associated with sqrt(b1) and the significance, or "p-value" of the skew test statistic zb1, assuming a two-tailed null hypothesis as well as .
skewSymmetric(float[][]) - Static method in class papaya.Mat
Returns the skew symmetric part of the input matrix ((A-A')/2).
slope(float, float, int) - Static method in class papaya.Linear.Significance
Returns the p-value, or significance, of the computed slope under the null-hypothesis of slope = 0 (two-tailed test).
slope(float[], float) - Static method in class papaya.Linear.StdErr
Returns the standard error of the computed slope given x and the standard error in the residuals.
solve(float[], boolean) - Method in class papaya.LU
Solve A*x = b for x
solve(float[][]) - Method in class papaya.LU
Solve A*X = B
solve(float[]) - Method in class papaya.QR
Least squares solution of A*X = b
solve(float[][]) - Method in class papaya.QR
Least squares solution of A*X = B
Sorting - Class in papaya
Class for getting the array of indices that can be used to sort the array in ascending or descending order.
spearman(float, int) - Static method in class papaya.Correlation.Significance
Returns the p-value, or significance level of the Spearman rank-correlation rho between two datasets under the null hypothesis of no correlation.
spearman(float[][], boolean) - Static method in class papaya.Correlation
Computes Spearman's rank-correlation, or rho, between multiple columns of a matrix with each column corresponding to a dataset, and each row an observation.
spearman(float[], float[], boolean) - Static method in class papaya.Correlation
Computes Spearman's rank-correlation, or rho.
spearman(float[][]) - Static method in class papaya.Distance
Computes the Spearman distance matrix of the m-by-n input matrix X.
split(float[], float[]) - Static method in class papaya.Mat
Splits (partitions) an array into sublists such that each sublist contains the elements with a given range.
SQRTH - Static variable in interface papaya.PapayaConstants
 
SQTPI - Static variable in interface papaya.PapayaConstants
 
squaredDeviations(int, float) - Static method in class papaya.Descriptive.Sum
Returns the sum of squared mean deviation of of a data sequence.
squares(float[]) - Static method in class papaya.Descriptive.Sum
Returns the sum of squares of a data sequence.
ssbg() - Method in class papaya.OneWayAnova
Returns the sum of squared deviates between each group.
sswg() - Method in class papaya.OneWayAnova
Returns the sum of squared deviates of the data within each group.
std(float[], boolean) - Static method in class papaya.Descriptive
Returns the standard deviation of a dataset.
std(float[][], boolean) - Static method in class papaya.Descriptive
Returns an array with each element of the array corresponding to the standard deviations of each column of the input matrix.
stdUnbiased(int, float) - Static method in class papaya.Descriptive
Returns the unbiased sample standard deviation assuming the sample is normally distributed.
STROKEWEIGHT - Static variable in interface papaya.PapayaConstants
 
subMatrix(float[][], int, int, int, int) - Static method in class papaya.Mat
Get a (2D) submatrix of a (2D) matrix (a copy, not a pointer).
subMatrix(float[][], int[], int, int) - Static method in class papaya.Mat
Function to get a (2D) submatrix of a (2D) matrix (a copy, not a pointer).
subMatrix(float[][], int, int, int[]) - Static method in class papaya.Mat
Function to get a (2D) submatrix of a (2D) matrix (a copy, not a pointer).
subMatrix(float[][], int[], int[]) - Static method in class papaya.Mat
Function to get a (2D) submatrix of a (2D) matrix (a copy, not a pointer).
subMatrix(int[][], int[], int[]) - Static method in class papaya.Mat
 
SubPlot - Class in papaya
Convenient class for drawing multiple scatter plots.
SubPlot(PApplet, float, float, float, float, int, int) - Constructor for class papaya.SubPlot
Creates numX*numY plots, each of with xWidth, and height yHeight.
subtract(float[], float[]) - Static method in class papaya.Mat
Returns the array z = x-y where each element of z[i] = x[i] - y[i]
subtract(float[][], float[][]) - Static method in class papaya.Mat
Returns the matrix z = x-y where each element of z[i][j] = x[i][j] - y[i][j]
sum(float[]) - Static method in class papaya.Descriptive.Sum
Returns the simple sum of a data sequence.
sum(float[]) - Static method in class papaya.Mat
Returns the sum of a data sequence.
sum(float[], float[]) - Static method in class papaya.Mat
Returns the sum of two data sequences.
sum(float[], float) - Static method in class papaya.Mat
Sum of an array with a number.
sum(int[]) - Static method in class papaya.Mat
Returns the sum of a data sequence.
sum(int[], int[]) - Static method in class papaya.Mat
Returns the sum of two data sequences.
sum(int[], int) - Static method in class papaya.Mat
Sum of an array with a number.
sum(float[][], float[][]) - Static method in class papaya.Mat
Returns the matrix z = x+y where each element of z[i][j] = x[i][j] + y[i][j]
SVD - Class in papaya
Singular Value Decomposition.
SVD(float[][]) - Constructor for class papaya.SVD
Construct the singular value decomposition.
swap(float[], int, int) - Static method in class papaya.Mat
Swap function that swaps the values in an array
swap(int[], int, int) - Static method in class papaya.Mat
Swap function that swaps the values in an array (overload function)
symmetric(float[][]) - Static method in class papaya.Mat
Returns the symmetric part of the input matrix ((A+A')/2).

T

tcdf(double, double) - Static method in class papaya.Probability
Returns the integral from minus infinity to t of the Student-t distribution with k > 0 degrees of freedom.
TEXTSIZE - Static variable in interface papaya.PapayaConstants
 
tinv(double, double) - Static method in class papaya.Probability
Returns the value, t, for which the area under the Student-t probability density function (integrated from minus infinity to t) is equal to p.
TOP - Static variable in interface papaya.PapayaConstants
 
topBound - Variable in class papaya.BoxPlot
Specifies the space on the top, between the plot area and the bounding rectangle.
topBound - Variable in class papaya.ScatterPlot
Specifies the space on the top, between the plot area and the bounding rectangle.
topBound - Variable in class papaya.SubPlot
Specifies the space on the top, between the plot area and the bounding rectangle.
trace(float[][]) - Static method in class papaya.Mat
Returns the matrix trace or sum of the diagonal elements.
transform(float[], float) - Static method in class papaya.Linear.BoxCox
Performs the box-cox transformation, returning the transformed data.
transpose(float[][]) - Static method in class papaya.Mat
Returns the transpose of the input matrix.
transpose(int[][]) - Static method in class papaya.Mat
 
trimmed(float[], float, int, int) - Static method in class papaya.Descriptive.Mean
Returns the trimmed arithmetic mean of a sorted data sequence.
tukeyFiveNum(float[]) - Static method in class papaya.Descriptive
Return the tukey five number summary of a dataset consisting of the minimum, maximum, and three quartile values.
twoArrays(float[], float[], int, int, boolean) - Static method in class papaya.Sorting
Sorts the input x and y arrays according to x and going from fromIndex(inclusive) to toIndex(exclusive) in ascending or descending order.
twoArrays(double[], double[], int, int, boolean) - Static method in class papaya.Sorting
 
twoArrays(int[], int[], int, int, boolean) - Static method in class papaya.Sorting
 

U

unequalVar(float[], float[]) - Static method in class papaya.Comparison.TTest
Returns the t-statistic and p-value for checking whether the means between the two datasets are different under the assumption that both datasets have unequal variances.
Unique - Class in papaya
Class for getting and storing an unsorted array's unique elements, the indices of these elements, and the number of times the elements occur.
Unique(float[], boolean) - Constructor for class papaya.Unique
Class for storing the unique values in an unsorted data array.
uniqueElems(int[]) - Static method in class papaya.Find
Find the unique elements in a int array (uses HashSets)
uniqueElems(float[]) - Static method in class papaya.Find
Find the unique elements in a float array (uses HashSets)

V

values - Variable in class papaya.Unique
ArrayList containing the unique values
var(float, int, float, int, boolean) - Static method in class papaya.Descriptive.Pooled
Returns the pooled variance of two data sequences.
var(float[], int[], boolean) - Static method in class papaya.Descriptive.Pooled
Returns the pooled variance of k data sequences.
var(float[], boolean) - Static method in class papaya.Descriptive
Returns the variance of a dataset, V.
var(float[][], boolean) - Static method in class papaya.Descriptive
Returns an array containing the variance of each column of the input matrix X.
var(float[], float[], boolean) - Static method in class papaya.Descriptive.Weighted
Returns the weighted variance of a data sequence of length N There are (unfortunately) many different definitions of the unbiased weighted variance.
vectorToFloat(Vector<Float>) - Static method in class papaya.Cast
function for casting Vector to float[]
vectorToInt(Vector<Integer>) - Static method in class papaya.Cast
function for casting Vector to int[]
vertLine(float, float, float, int, float) - Method in class papaya.Visuals
draws a vertical line with color _sColor, and weight _sWeight
Visuals - Class in papaya
Visuals is the parent class behind most of the other plotting classes.
Visuals(PApplet, float, float, float, float) - Constructor for class papaya.Visuals
The parent class behind the other plotting classes.

W

winsorized(float[], float, int, int) - Static method in class papaya.Descriptive.Mean
Returns the winsorized mean of a sorted data sequence.
within(float, float, float) - Static method in class papaya.Mat
Checks to see if a number is in the range specified by [min,max].
within(float[], float, float) - Static method in class papaya.Mat
returns an array containing all numbers within the min and max (inclusive).
writeLabels(PFont, String[], float[], float[]) - Method in class papaya.Visuals
 
writeLabels(PFont, String, float, float) - Method in class papaya.Visuals
 
writeLabels(PFont, float, float, float) - Method in class papaya.Visuals
 
writeLabels(float, float, float) - Method in class papaya.Visuals
 
writeLabels(String, float, float) - Method in class papaya.Visuals
 
writeTitle(PFont, String, int, int) - Method in class papaya.SubPlot
Writes the title for subplot(xnum,ynum).
writeTitle(String, int, int) - Method in class papaya.SubPlot
Writes the title for subplot(xnum,ynum).
writeTitle(String, PFont) - Method in class papaya.Visuals
titles the plot given the String _title and the PFont

X

xLabels(int, int, int) - Method in class papaya.SubPlot
Writes the x labels for subplot(xnum,ynum).
xLabels(float, float, float, float, int) - Method in class papaya.Visuals
Write the x-axis labels.
xLabels(float, float, String[]) - Method in class papaya.Visuals
Write the x-axis labels.
xLefts - Variable in class papaya.SubPlot
 
xSpacing - Variable in class papaya.SubPlot
 
xTicks(float, float, int, int) - Method in class papaya.Visuals
Draws the x-axis tickmarks.
xW - Variable in class papaya.SubPlot
 
XYLabels - Variable in class papaya.ScatterPlot
 
XYTicks - Variable in class papaya.ScatterPlot
 

Y

yH - Variable in class papaya.SubPlot
 
yLabels(int, int, int) - Method in class papaya.SubPlot
Writes the y labels for subplot(xnum,ynum).
yLabels(float, float, float, float, int) - Method in class papaya.Visuals
Write the y-axis labels.
yLabels(float, float, String[]) - Method in class papaya.Visuals
Write the y-axis labels.
YLines(int) - Method in class papaya.Visuals
Draws horizontal y-lines on the plot
ySpacing - Variable in class papaya.SubPlot
 
yTicks(float, float, int, int) - Method in class papaya.Visuals
Draws the y-axis tickmarks.
yTops - Variable in class papaya.SubPlot
 

Z

zScore(float, float, float) - Static method in class papaya.Descriptive
 
zScore(float[], float, float) - Static method in class papaya.Descriptive
Returns the array of z-scores for a given data array.
zScore(float[][], float[], float[]) - Static method in class papaya.Descriptive
Computes the standardized version of the input matrix.

A B C D E F G H I K L M N O P Q R S T U V W X Y Z

Processing library papaya by Adila Faruk. (C) 2014