- actionPerformed(ActionEvent) - Method in class datan.AuxJNumberInput
-
- add(JComponent) - Method in class datan.DatanFrame
-
Adds a JComponent to the Frame which may be used for interactive input or steering of example program
- add(DatanMatrix) - Method in class datan.DatanMatrix
-
Returns the sum with the matrix b.
- add(DatanVector) - Method in class datan.DatanVector
-
Returns sum with vector b.
- addNumberInput(AuxJNumberInput) - Method in class datan.AuxJInputGroup
-
adds an element of type AuxJNumberInput.
- addText(String) - Method in class datan.AuxJInputGroup
-
adds a text string which will be placed on a label.
- addText(String) - Method in class datan.AuxJRButtonGroup
-
adds a text string which will be placed on a label.
- AnalysisOfVariance - Class in datan
-
A class performing an analysis of variance
- AnalysisOfVariance(double[][][]) - Constructor for class datan.AnalysisOfVariance
-
- applyGivensTransformation(double[], double[]) - Method in class datan.DatanMatrix
-
Applies Givens Transformation to the two vector components z.
- applyHouseholderTransformation(DatanVector, DatanVector, int, int, double[]) - Method in class datan.DatanMatrix
-
Applies Householder Transformation to Vector c.
- AuxDer - Class in datan
-
A class computing the derivative f'(x) of f(x) at x = X.
- AuxDer(DatanUserFunction) - Constructor for class datan.AuxDer
-
- AuxDri - Class in datan
-
A class computing the Matrix A of derivatives needed int classes LsqNon and LsqMar
- AuxDri(DatanUserFunction, DatanVector, DatanVector, int[]) - Constructor for class datan.AuxDri
-
- AuxGrad - Class in datan
-
A class computing the gradient vector of a function of n variables
- AuxGrad(DatanUserFunction, int[]) - Constructor for class datan.AuxGrad
-
- AuxHesse - Class in datan
-
A class computing the Hessian matrix of second derivatives of a function of n variables
- AuxHesse(DatanUserFunction, int[]) - Constructor for class datan.AuxHesse
-
- AuxJInputGroup - Class in datan
-
A class representing a JPanel with a border, a border title, and
a tooltip text, to which other elements can be added, one below the other.
- AuxJInputGroup(String, String) - Constructor for class datan.AuxJInputGroup
-
ceates an AuxJInputGroup, which is a JPanel with a border, a border title,
a tooltip text to which other elements can be added, one below the other.
- AuxJNumberInput - Class in datan
-
A class representing a JPanel carrying a JLabel with Text (and tooltip text)
and a JTextField for numerical input, the validity of which is checked.
- AuxJNumberInput(String, String, JLabel) - Constructor for class datan.AuxJNumberInput
-
creates an AuxJNumberInput which is a JPanel carrying a JLabel with Text (and tooltip text)
and a JTextField for numerical input, the validity of which is checked.
- AuxJNumberInput(String, String, JLabel, double, double) - Constructor for class datan.AuxJNumberInput
-
creates an AuxJNumberInput which is a JPanel carrying a JLabel with Text (and tooltip text)
and a JTextField for numerical input, the validity of which is checked.
- AuxJRButtonGroup - Class in datan
-
A class representing a JPanel carrying a vertical row of radio buttons with a border, a border title,
a tooltip text; all buttons are listened to by the same ActionListener.
- AuxJRButtonGroup(String, String, String[], ActionListener) - Constructor for class datan.AuxJRButtonGroup
-
ceates an AuxJRbuttonGroup, which is a JPanel carrying a vertical row of radio buttons with a border, a border title,
a tooltip text; all buttons are listened to by the same ActionListener.
- AuxZero - Class in datan
-
A class with which a zero of a scalar monotonic function of a single variable is found
- AuxZero(DatanUserFunction, double, double) - Constructor for class datan.AuxZero
-
- datan - package datan
-
- DatanFrame - Class in datan
-
A class providing a JFrame with input and output possibilities for Datan examples.
- DatanFrame(String, String, String) - Constructor for class datan.DatanFrame
-
Creates a JFrame with a scroll pane for output and opens a file for a copy of that output
- DatanFrame(String, String) - Constructor for class datan.DatanFrame
-
Creates a JFrame with a scroll pane for output
- datangraphics - package datangraphics
-
- DatanGraphicsFrame - Class in datangraphics
-
A class representing a graphics frame.
- DatanGraphicsFrame(String, String, int, double, double, int, int[], short[]) - Constructor for class datangraphics.DatanGraphicsFrame
-
- DatanMatrix - Class in datan
-
A class representing a matrix.
- DatanMatrix(DatanMatrix) - Constructor for class datan.DatanMatrix
-
Creates a matrix which is a copy of b.
- DatanMatrix(int) - Constructor for class datan.DatanMatrix
-
Creates an (n x n) unit matrix.
- DatanMatrix(int, int) - Constructor for class datan.DatanMatrix
-
Creates an (n x m) matrix all elements of which contain a zero (null matrix).
- DatanMatrix(double[][]) - Constructor for class datan.DatanMatrix
-
Creates a matrix the elements of which are given by a.
- DatanMatrix(double[]) - Constructor for class datan.DatanMatrix
-
Creates a matrix with only one column the elements of which are given by a.
- DatanMatrix(DatanVector) - Constructor for class datan.DatanMatrix
-
Creates a matrix with only one column representing vector v).
- DatanRandom - Class in datan
-
A class providing methods for computing random numbers
- DatanRandom() - Constructor for class datan.DatanRandom
-
- DatanUserFunction - Class in datan
-
An abstract class which has to be extended by the user to yield a class computing a scalar function
- DatanUserFunction() - Constructor for class datan.DatanUserFunction
-
- DatanVector - Class in datan
-
A class representing a vector.
- DatanVector(int) - Constructor for class datan.DatanVector
-
Creates a vector with n elements which are all zero.
- DatanVector(int, double[]) - Constructor for class datan.DatanVector
-
Creates a vector with n elements from the array b.
- DatanVector(double[]) - Constructor for class datan.DatanVector
-
Creates a vector from the array b.
- DatanVector(DatanVector) - Constructor for class datan.DatanVector
-
Creates a vector which is a copy of b.
- defineAndApplyGivensTransformation(double[], double[]) - Method in class datan.DatanMatrix
-
Defines Givens transformation and applies it to the defining vector.
- defineGivensTransformation(double[], double[]) - Method in class datan.DatanMatrix
-
Defines Givens transformation.
- defineHouseholderTransformation(DatanVector, int, int, double[]) - Method in class datan.DatanMatrix
-
Defines a Householder Transformation.
- defineInput() - Method in class examples.FunctionsDemo
-
- displayData() - Method in class datan.AnalysisOfVariance
-
- dispose() - Method in class datangraphics.DatanGraphicsFrame
-
- dot(DatanVector) - Method in class datan.DatanVector
-
Returns scalar product with vector b.
- E10Mtx - Class in examples
-
Example for the solution of the least squares problem with constraints
- E10Mtx() - Constructor for class examples.E10Mtx
-
- E1Anova - Class in examples
-
Example demonstrating the use of class AnanysisOfVariance
- E1Anova() - Constructor for class examples.E1Anova
-
- E1Distrib - Class in examples
-
Example simulating empirical frequency and demonstrating statistical fluctuations using method DatanRandom.ecuy
- E1Distrib() - Constructor for class examples.E1Distrib
-
- E1Gr - Class in examples
-
Example demonstrating the basic methods of class DatanGrphics
- E1Gr() - Constructor for class examples.E1Gr
-
- E1Lsq - Class in examples
-
Example demonstrating the fit of polynomials of different degrees to dat
- E1Lsq() - Constructor for class examples.E1Lsq
-
- E1MaxLike - Class in examples
-
Example simulating decay times and determining mean life by maximum likelihood
- E1MaxLike() - Constructor for class examples.E1MaxLike
-
- E1Min - Class in examples
-
Example demonstrating the use of various minimization methods
- E1Min() - Constructor for class examples.E1Min
-
- E1Mtx - Class in examples
-
Examples for simple matrix and vector operations
- E1Mtx() - Constructor for class examples.E1Mtx
-
- E1Random - Class in examples
-
Example for the creation of random numbers
- E1Random() - Constructor for class examples.E1Random
-
- E1Reg - Class in examples
-
- E1Reg() - Constructor for class examples.E1Reg
-
- E1Sample - Class in examples
-
Example drawing a sample from the standard noraml distribution and computing various sample quantities
- E1Sample() - Constructor for class examples.E1Sample
-
- E1Test - Class in examples
-
Example simulating 2 Gaussian samples and performing an F-test for equality of variances
- E1Test() - Constructor for class examples.E1Test
-
- E1TimSer - Class in examples
-
Example demonstrating a time series analysis
- E1TimSer() - Constructor for class examples.E1TimSer
-
- E2Anova - Class in examples
-
Example performing an analysis of variance on simulated data
- E2Anova() - Constructor for class examples.E2Anova
-
- E2Distrib - Class in examples
-
Example simulating the experiment by Rutherford and Geiger on the statistical nature of radioactive decays
- E2Distrib() - Constructor for class examples.E2Distrib
-
- E2Gr - Class in examples
-
Example demonstrating the use of method DatanGraphics.drawMark
- E2Gr() - Constructor for class examples.E2Gr
-
- E2Lsq - Class in examples
-
Example demonstrating the fit of a linear function to data
- E2Lsq() - Constructor for class examples.E2Lsq
-
- E2MaxLike - Class in examples
-
Example estimating by the maximum-likelihood method the parameters of a bivariate Gaussian
- E2MaxLike() - Constructor for class examples.E2MaxLike
-
- E2Min - Class in examples
-
Example demonstrating the use of class MinCov by fitting a Gaussian to small sample and determining errors of parameters by MinCov
- E2Min() - Constructor for class examples.E2Min
-
- E2Mtx - Class in examples
-
Examples for manipulation of submatrices and subvectors
- E2Mtx() - Constructor for class examples.E2Mtx
-
- E2Random - Class in examples
-
Example creating points fluctuating about a straight line, using the method DatanRandom.line
- E2Random() - Constructor for class examples.E2Random
-
- E2Reg - Class in examples
-
- E2Reg() - Constructor for class examples.E2Reg
-
- E2Sample - Class in examples
-
Example demonstrating the use of the classes Histogram and GraphicsWithHistogram
- E2Sample() - Constructor for class examples.E2Sample
-
- E2Test - Class in examples
-
Example simulating a Gaussian sample and performing a t-test on its mean
- E2Test() - Constructor for class examples.E2Test
-
- E2TimSer - Class in examples
-
Example demonstrating atime series analysis
- E2TimSer() - Constructor for class examples.E2TimSer
-
- E3Distrib - Class in examples
-
Example simulating simulating Galton's board and demonstratng statistical fluctuation
- E3Distrib() - Constructor for class examples.E3Distrib
-
- E3Gr - Class in examples
-
Example demonstrating use of method DatanGraphics.drawPoint
- E3Gr() - Constructor for class examples.E3Gr
-
- E3Lsq - Class in examples
-
Example demonstrating the fit of a nonlinear function to data
- E3Lsq() - Constructor for class examples.E3Lsq
-
- E3Min - Class in examples
-
Example demonstrating the use of class MinAsy by fitting a Gaussian to small sample and determining the asymmetric errors of parameters by MinAs
- E3Min() - Constructor for class examples.E3Min
-
- E3Mtx - Class in examples
-
Examples for use of Givens transformations
- E3Mtx() - Constructor for class examples.E3Mtx
-
- E3Random - Class in examples
-
Example simulating decay times for a radioactive source with two components using the method DatanRandom.radio
- E3Random() - Constructor for class examples.E3Random
-
- E3Reg - Class in examples
-
- E3Reg() - Constructor for class examples.E3Reg
-
- E3Sample - Class in examples
-
Example producing a random sample from a bivariate Gaussian distribution and presenting it in a 2D scatter diagram
- E3Sample() - Constructor for class examples.E3Sample
-
- E3Test - Class in examples
-
Example simulating chi-squared tests of measurements
- E3Test() - Constructor for class examples.E3Test
-
- E4Gr - Class in examples
-
Example for the use of method DatanGraphics.drawContour
- E4Gr() - Constructor for class examples.E4Gr
-
- E4Lsq - Class in examples
-
Example demonstrating the fit of a nonlinear function to data
- E4Lsq() - Constructor for class examples.E4Lsq
-
- E4Min - Class in examples
-
Example performing the fit of a Gaussian to a histogram
- E4Min() - Constructor for class examples.E4Min
-
- E4Mtx - Class in examples
-
Examples for use of Householder transformations
- E4Mtx() - Constructor for class examples.E4Mtx
-
- E4Random - Class in examples
-
Example producing a random sample from a bivariate Gaussian distribution
- E4Random() - Constructor for class examples.E4Random
-
- E4Reg - Class in examples
-
- E4Reg() - Constructor for class examples.E4Reg
-
- E4Sample - Class in examples
-
Example demonstrating the use of the class SmallSample to compute confidence limits on the Poisson parameter in the presence of background
- E4Sample() - Constructor for class examples.E4Sample
-
- E5Gr - Class in examples
-
Example demonstrating the use of methods DatanGrphics.drawCoordinateCross and DatanGrphics.setParametersForScale
- E5Gr() - Constructor for class examples.E5Gr
-
- E5Lsq - Class in examples
-
Example demonstrating the fit of a nonlinear function to data using LsqMar
- E5Lsq() - Constructor for class examples.E5Lsq
-
- E5Mtx - Class in examples
-
Examples for solving matrix equations
- E5Mtx() - Constructor for class examples.E5Mtx
-
- E5Sample - Class in examples
-
Example demonstrating the use of the class SmallSample to compute confidence limits on the ratio of signal and reference events in the presence of background
- E5Sample() - Constructor for class examples.E5Sample
-
- E6Gr - Class in examples
-
Example for the use of class GraphicsWithHistogramAndPolyline
- E6Gr() - Constructor for class examples.E6Gr
-
- E6Lsq - Class in examples
-
Example demonstrating the general case of least squares fitting
- E6Lsq() - Constructor for class examples.E6Lsq
-
- E6Mtx - Class in examples
-
Examples for Cholesky decomposition and inversion
- E6Mtx() - Constructor for class examples.E6Mtx
-
- E6Sample - Class in examples
-
Example simulating experiments with few events and background
- E6Sample() - Constructor for class examples.E6Sample
-
- E7Gr - Class in examples
-
Example for the use of class GraphicsWithDataPointsAndPolyline
- E7Gr() - Constructor for class examples.E7Gr
-
- E7Lsq - Class in examples
-
Example demonstrating the general case of least squares fitting, one unknown fixed
- E7Lsq() - Constructor for class examples.E7Lsq
-
- E7Mtx - Class in examples
-
Examples for computation of psudoinverse of a square matrix
- E7Mtx() - Constructor for class examples.E7Mtx
-
- E7Sample - Class in examples
-
Example simulating experiments with few signal events and with reference events
- E7Sample() - Constructor for class examples.E7Sample
-
- E8Gr - Class in examples
-
Example for the use of classes GraphicsWithDataPointsAndPolyline and GraphicsWithDataPointsAndMultiplePolylines
- E8Gr() - Constructor for class examples.E8Gr
-
- E8Lsq - Class in examples
-
Example demonstrating the the problem of constrained measurements
- E8Lsq() - Constructor for class examples.E8Lsq
-
- E8Mtx - Class in examples
-
Examples for the solution of matrix equations by singular value decomposition
- E8Mtx() - Constructor for class examples.E8Mtx
-
- E9Lsq - Class in examples
-
Example demonstrating the general case of least squares fitting, including plot of parameter plane with confidence region and asymmetric errors.
- E9Lsq() - Constructor for class examples.E9Lsq
-
- E9Mtx - Class in examples
-
Example for use of Marquardt's method in connection with singular value decomposition
- E9Mtx() - Constructor for class examples.E9Mtx
-
- ecuy(int) - Static method in class datan.DatanRandom
-
Combination of two MLC generators which returns an array containing n random numbers;
the method is also the basis for all other genrators in this class except mlcg.
- enter(double, double) - Method in class datan.Histogram
-
Enters xin in the appropriate bin with a user-defined weight.
- enter(double) - Method in class datan.Histogram
-
Enters xin in the appropriate bin with weight 1.
- examples - package examples
-
- Gamma - Class in datan
-
A class providing methods for computing the Gamma function and related functions
- Gamma() - Constructor for class datan.Gamma
-
- gamma(double) - Static method in class datan.Gamma
-
returns Gamma function
- getAsymmetricErrors(double) - Method in class datan.LsqAsg
-
- getAsymmetricErrors(double) - Method in class datan.LsqAsm
-
- getAsymmetricErrors(double) - Method in class datan.LsqAsn
-
- getAsymmetricErrors(double) - Method in class datan.MinAsy
-
- getBinSize() - Method in class datan.Histogram
-
- getChiSquare() - Method in class datan.LsqGen
-
- getChiSquare() - Method in class datan.LsqLin
-
- getChiSquare() - Method in class datan.LsqMar
-
- getChiSquare() - Method in class datan.LsqNon
-
- getChiSquare() - Method in class datan.LsqPol
-
- getChiSquare() - Method in class datan.Regression
-
- getColumn(int) - Method in class datan.DatanMatrix
-
Returns the column vector with column index k.
- getConfidenceLimits() - Method in class datan.TimeSeries
-
- getContents() - Method in class datan.Histogram
-
- getContentsAt(int) - Method in class datan.Histogram
-
- getCovarianceMatrix() - Method in class datan.LsqGen
-
- getCovarianceMatrix() - Method in class datan.LsqLin
-
- getCovarianceMatrix() - Method in class datan.LsqMar
-
- getCovarianceMatrix() - Method in class datan.LsqNon
-
- getCovarianceMatrix() - Method in class datan.LsqPol
-
- getCovarianceMatrix(double) - Method in class datan.MinCov
-
- getCovarianceMatrixOfImprovedMeasurements() - Method in class datan.LsqGen
-
- getDerivative(double) - Method in class datan.AuxDer
-
- getElement(int, int) - Method in class datan.DatanMatrix
-
Returns element (i,j).
- getElement(int) - Method in class datan.DatanVector
-
Returns elements i.
- getErrorOfMean() - Method in class datan.Sample
-
Returns the error of the sample mean.
- getErrorOfStandardDeviation() - Method in class datan.Sample
-
Returns the error of the standard deviation of the sample.
- getErrorOfVariance() - Method in class datan.Sample
-
Returns the error of the sample variance.
- getFunctionOnLine(double) - Method in class datan.FunctionOnLine
-
- getGradient(DatanVector) - Method in class datan.AuxGrad
-
- getHessian(DatanVector) - Method in class datan.AuxHesse
-
- getImprovedMeasurements() - Method in class datan.LsqGen
-
- getIndex() - Method in class datangraphics.DatanGraphicsFrame
-
- getLabelText() - Method in class datan.AuxJNumberInput
-
returns label text.
- getLowerBoundary() - Method in class datan.Histogram
-
- getMatrixOfDerivatives(DatanVector) - Method in class datan.AuxDri
-
- getMean() - Method in class datan.Sample
-
Returns trhe sample mean.
- getMinimum() - Method in class datan.MinCjg
-
- getMinimum() - Method in class datan.MinDir
-
- getMinimum() - Method in class datan.MinMar
-
- getMinimum() - Method in class datan.MinPow
-
- getMinimum() - Method in class datan.MinQdr
-
- getMinimum() - Method in class datan.MinSim
-
- getMinPosition() - Method in class datan.MinCjg
-
- getMinPosition() - Method in class datan.MinDir
-
- getMinPosition() - Method in class datan.MinMar
-
- getMinPosition() - Method in class datan.MinPow
-
- getMinPosition() - Method in class datan.MinQdr
-
- getMinPosition() - Method in class datan.MinSim
-
- getMovingAverages() - Method in class datan.TimeSeries
-
- getNumberOfBins() - Method in class datan.Histogram
-
- getNumberOfColumns() - Method in class datan.DatanMatrix
-
Returns number of columns.
- getNumberOfElements() - Method in class datan.DatanVector
-
Returns the number of elements.
- getNumberOfRows() - Method in class datan.DatanMatrix
-
Returns number of rows.
- getParameters() - Method in class datan.Regression
-
- getPositionOfExtremum(double, double, double, double, double, double) - Static method in class datan.MinParab
-
gets position of extremum
- getResult() - Method in class datan.LsqGen
-
- getResult() - Method in class datan.LsqLin
-
- getResult() - Method in class datan.LsqMar
-
- getResult() - Method in class datan.LsqNon
-
- getResult() - Method in class datan.LsqPol
-
- getRow(int) - Method in class datan.DatanMatrix
-
Returns the row vector with row index k.
- getSeedMlcg() - Static method in class datan.DatanRandom
-
gets current seed of MLC generator.
- getSeedsEcuy() - Static method in class datan.DatanRandom
-
gets current seeds of combined generator Ecuy; seeds has 2 elements.
- getSelectedIndex() - Method in class datan.AuxJRButtonGroup
-
returns the index of the selected radio button.
- getStandardDeviation() - Method in class datan.Sample
-
Returns the standard deviation of the sample.
- getSteps() - Method in class datan.MinCjg
-
- getSteps() - Method in class datan.MinCombined
-
- getSteps() - Method in class datan.MinEnclose
-
- getSteps() - Method in class datan.MinGold
-
- getSteps() - Method in class datan.MinMar
-
- getSteps() - Method in class datan.MinPow
-
- getSteps() - Method in class datan.MinQdr
-
- getSteps() - Method in class datan.MinSim
-
- getSubmatrix(int, int, int, int) - Method in class datan.DatanMatrix
-
Returns a submatrix.
- getSubvector(int[]) - Method in class datan.DatanVector
-
Returns subvector defined by a list.
- getTotalContents() - Method in class datan.Histogram
-
- getValue(double, double) - Method in class datan.DatanUserFunction
-
- getValue(DatanVector, double) - Method in class datan.DatanUserFunction
-
- getValue(DatanVector) - Method in class datan.DatanUserFunction
-
- getValue(double) - Method in class datan.DatanUserFunction
-
- getValue(DatanVector, DatanVector, int) - Method in class datan.DatanUserFunction
-
- getVariance() - Method in class datan.Sample
-
Returns the sample variance.
- getX() - Method in class datan.MinCombined
-
- getX() - Method in class datan.MinGold
-
- getXValues() - Method in class datan.MinEnclose
-
- getY() - Method in class datan.MinCombined
-
- getY() - Method in class datan.MinGold
-
- getYValues() - Method in class datan.MinEnclose
-
- getZero() - Method in class datan.AuxZero
-
- GraphicsWith2DScatterDiagram - Class in datangraphics
-
A class producing a graphics with a two-dimensional scatter diagram.
- GraphicsWith2DScatterDiagram(String, String, double[], double[], double, double, double, double, String, String, String) - Constructor for class datangraphics.GraphicsWith2DScatterDiagram
-
Produces a two-dimensional scatter diagram.
- GraphicsWithDataPointsAndMultiplePolylines - Class in datangraphics
-
A class producing a plot with data points and several polylines.
- GraphicsWithDataPointsAndMultiplePolylines(String, String, double[][], double[][], int[], int, double, double[], double[], double[], double[], double[], String, String, String) - Constructor for class datangraphics.GraphicsWithDataPointsAndMultiplePolylines
-
Produces a plot with data points and severalpolylines.
- GraphicsWithDataPointsAndPolyline - Class in datangraphics
-
A class producing a plot with data points and a polyline.
- GraphicsWithDataPointsAndPolyline(String, String, double[], double[], int, double, double[], double[], double[], double[], double[], String, String, String) - Constructor for class datangraphics.GraphicsWithDataPointsAndPolyline
-
Produces a plot with data points and a polyline.
- GraphicsWithHistogram - Class in datangraphics
-
A class producing a graphics with histogram and polyline.
- GraphicsWithHistogram(String, String, Histogram, String, String, String) - Constructor for class datangraphics.GraphicsWithHistogram
-
Produces a plot with a histogram.
- GraphicsWithHistogramAndPolyline - Class in datangraphics
-
A class producing a graphics with histogram and polyline.
- GraphicsWithHistogramAndPolyline(String, String, double[], double[], Histogram, String, String, String) - Constructor for class datangraphics.GraphicsWithHistogramAndPolyline
-
Produces a plot with a histogram and a polyline.
- main(String[]) - Static method in class examples.E10Mtx
-
- main(String[]) - Static method in class examples.E1Anova
-
- main(String[]) - Static method in class examples.E1Distrib
-
- main(String[]) - Static method in class examples.E1Gr
-
- main(String[]) - Static method in class examples.E1Lsq
-
- main(String[]) - Static method in class examples.E1MaxLike
-
- main(String[]) - Static method in class examples.E1Min
-
- main(String[]) - Static method in class examples.E1Mtx
-
- main(String[]) - Static method in class examples.E1Random
-
- main(String[]) - Static method in class examples.E1Reg
-
- main(String[]) - Static method in class examples.E1Sample
-
- main(String[]) - Static method in class examples.E1Test
-
- main(String[]) - Static method in class examples.E1TimSer
-
- main(String[]) - Static method in class examples.E2Anova
-
- main(String[]) - Static method in class examples.E2Distrib
-
- main(String[]) - Static method in class examples.E2Gr
-
- main(String[]) - Static method in class examples.E2Lsq
-
- main(String[]) - Static method in class examples.E2MaxLike
-
- main(String[]) - Static method in class examples.E2Min
-
- main(String[]) - Static method in class examples.E2Mtx
-
- main(String[]) - Static method in class examples.E2Random
-
- main(String[]) - Static method in class examples.E2Reg
-
- main(String[]) - Static method in class examples.E2Sample
-
- main(String[]) - Static method in class examples.E2Test
-
- main(String[]) - Static method in class examples.E2TimSer
-
- main(String[]) - Static method in class examples.E3Distrib
-
- main(String[]) - Static method in class examples.E3Gr
-
- main(String[]) - Static method in class examples.E3Lsq
-
- main(String[]) - Static method in class examples.E3Min
-
- main(String[]) - Static method in class examples.E3Mtx
-
- main(String[]) - Static method in class examples.E3Random
-
- main(String[]) - Static method in class examples.E3Reg
-
- main(String[]) - Static method in class examples.E3Sample
-
- main(String[]) - Static method in class examples.E3Test
-
- main(String[]) - Static method in class examples.E4Gr
-
- main(String[]) - Static method in class examples.E4Lsq
-
- main(String[]) - Static method in class examples.E4Min
-
- main(String[]) - Static method in class examples.E4Mtx
-
- main(String[]) - Static method in class examples.E4Random
-
- main(String[]) - Static method in class examples.E4Reg
-
- main(String[]) - Static method in class examples.E4Sample
-
- main(String[]) - Static method in class examples.E5Gr
-
- main(String[]) - Static method in class examples.E5Lsq
-
- main(String[]) - Static method in class examples.E5Mtx
-
- main(String[]) - Static method in class examples.E5Sample
-
- main(String[]) - Static method in class examples.E6Gr
-
- main(String[]) - Static method in class examples.E6Lsq
-
- main(String[]) - Static method in class examples.E6Mtx
-
- main(String[]) - Static method in class examples.E6Sample
-
- main(String[]) - Static method in class examples.E7Gr
-
- main(String[]) - Static method in class examples.E7Lsq
-
- main(String[]) - Static method in class examples.E7Mtx
-
- main(String[]) - Static method in class examples.E7Sample
-
- main(String[]) - Static method in class examples.E8Gr
-
- main(String[]) - Static method in class examples.E8Lsq
-
- main(String[]) - Static method in class examples.E8Mtx
-
- main(String[]) - Static method in class examples.E9Lsq
-
- main(String[]) - Static method in class examples.E9Mtx
-
- main(String[]) - Static method in class examples.FunctionsDemo
-
- main(String[]) - Static method in class solutions.S1Anova
-
- main(String[]) - Static method in class solutions.S1Distrib
-
- main(String[]) - Static method in class solutions.S1Lsq
-
- main(String[]) - Static method in class solutions.S1MaxLike
-
- main(String[]) - Static method in class solutions.S1Min
-
- main(String[]) - Static method in class solutions.S1Random
-
- main(String[]) - Static method in class solutions.S1Reg
-
- main(String[]) - Static method in class solutions.S1TimSer
-
- main(String[]) - Static method in class solutions.S2Anova
-
- main(String[]) - Static method in class solutions.S2Distrib
-
- main(String[]) - Static method in class solutions.S2Lsq
-
- main(String[]) - Static method in class solutions.S2MaxLike
-
- main(String[]) - Static method in class solutions.S2Min
-
- main(String[]) - Static method in class solutions.S2Random
-
- main(String[]) - Static method in class solutions.S2Reg
-
- main(String[]) - Static method in class solutions.S2TimSer
-
- main(String[]) - Static method in class solutions.S3Lsq
-
- main(String[]) - Static method in class solutions.S3Random
-
- main(String[]) - Static method in class solutions.S4Lsq
-
- main(String[]) - Static method in class solutions.S5Lsq
-
- main(String[]) - Static method in class solutions.S6Lsq
-
- main(String[]) - Static method in class solutions.S7Lsq
-
- makeTextPanel(String) - Method in class examples.E1Min
-
- makeTextPanel(String) - Method in class examples.FunctionsDemo
-
- makeTextPanel(String) - Method in class solutions.S1Min
-
- marquardt(DatanVector, double, DatanVector, DatanVector, double, boolean[]) - Method in class datan.DatanMatrix
-
Yields the solution vectors (x1 and x2) appearing in Marquardt's method to solve the matrix equation a x = b, where a is this matrix.
- matrixEquation(DatanMatrix) - Method in class datan.DatanMatrix
-
Solves matrix equation a x = b where b is original matrix; after call it contains the solution x.
- MinAsy - Class in datan
-
A class determining the asymmetric errors
for a set of parameters determined by minimization.
- MinAsy(DatanVector, int[], DatanMatrix, DatanUserFunction) - Constructor for class datan.MinAsy
-
- MinAsy(DatanVector, DatanMatrix, DatanUserFunction) - Constructor for class datan.MinAsy
-
- MinCjg - Class in datan
-
A class determining the minimum of a function in n-dimensional space by the method of conjugate directions.
- MinCjg(DatanVector, int[], DatanUserFunction) - Constructor for class datan.MinCjg
-
- MinCjg(DatanVector, DatanUserFunction) - Constructor for class datan.MinCjg
-
- MinCjg(DatanVector, int[], int, double, DatanUserFunction) - Constructor for class datan.MinCjg
-
- MinCombined - Class in datan
-
A class determining the minimum of a function along a straight line in n-dimensional space
according to combination the method of the golden section and of quadratic interpolation
- MinCombined(double, double, DatanVector, DatanVector, int, double, DatanUserFunction) - Constructor for class datan.MinCombined
-
- MinCov - Class in datan
-
A class determining the covariance matrix / confidence matrix
for a set of parameters determined by minimization.
- MinCov(DatanVector, int[], DatanUserFunction) - Constructor for class datan.MinCov
-
- MinCov(DatanVector, DatanUserFunction) - Constructor for class datan.MinCov
-
- MinDir - Class in datan
-
A class determining the minimum of a function along a straight line in n-dimensional space.
- MinDir(DatanVector, DatanVector, int, double, DatanUserFunction) - Constructor for class datan.MinDir
-
- MinEnclose - Class in datan
-
A class trying to find an interval along a straight line in n-dimensional space which contains
the minimum on that line of a function in n-space.
- MinEnclose(double, double, DatanVector, DatanVector, int, DatanUserFunction) - Constructor for class datan.MinEnclose
-
- MinGold - Class in datan
-
A class determining the minimum of a function along a straight line in n-dimensional space
according to the method of the golden section
- MinGold(double, double, double, DatanVector, DatanVector, int, double, DatanUserFunction) - Constructor for class datan.MinGold
-
- MinMar - Class in datan
-
A class determining the minimum of a function in n-dimensional space by Marquardt's method of.
- MinMar(DatanVector, int[], DatanUserFunction) - Constructor for class datan.MinMar
-
- MinMar(DatanVector, DatanUserFunction) - Constructor for class datan.MinMar
-
- MinMar(DatanVector, int[], int, double, DatanUserFunction) - Constructor for class datan.MinMar
-
- MinParab - Class in datan
-
A class determining the extremum of a parabola through three points (xa,ya), (xb,yb),(xb,yc).
- MinParab() - Constructor for class datan.MinParab
-
- MinPow - Class in datan
-
A class determining the minimum of a function in n-dimensional space by Powell's method of selected directions.
- MinPow(DatanVector, int[], DatanUserFunction) - Constructor for class datan.MinPow
-
- MinPow(DatanVector, DatanUserFunction) - Constructor for class datan.MinPow
-
- MinPow(DatanVector, int[], int, double, DatanUserFunction) - Constructor for class datan.MinPow
-
- MinQdr - Class in datan
-
A class determining the minimum of a function in n-dimensional space by the method of of the quadratic form.
- MinQdr(DatanVector, int[], DatanUserFunction) - Constructor for class datan.MinQdr
-
- MinQdr(DatanVector, DatanUserFunction) - Constructor for class datan.MinQdr
-
- MinQdr(DatanVector, int[], int, double, DatanUserFunction) - Constructor for class datan.MinQdr
-
- MinSim - Class in datan
-
A class determining the minimum of a function in n-dimensional space by the simplex method.
- MinSim(DatanVector, int[], DatanUserFunction) - Constructor for class datan.MinSim
-
- MinSim(DatanVector, DatanUserFunction) - Constructor for class datan.MinSim
-
- MinSim(DatanVector, int[], int, double, double, DatanUserFunction) - Constructor for class datan.MinSim
-
- mlcg(int) - Static method in class datan.DatanRandom
-
MLC generator which returns an array containing n random numbers.
- multiply(double) - Method in class datan.DatanMatrix
-
Returns the product of this matrix and the scalar s.
- multiply(DatanVector) - Method in class datan.DatanMatrix
-
Returns the vector obtained by multipying this matrix from the right with the (column) vector v.
- multiply(DatanMatrix) - Method in class datan.DatanMatrix
-
Returns the matrix obtained by multipying this matrix from the right with the matrix b.
- multiply(double) - Method in class datan.DatanVector
-
Returns product with scalar s.
- multiplyTransposedWith(DatanMatrix) - Method in class datan.DatanMatrix
-
Returns the matrix obtained by multipying the transposed of this matrix from the right with the matrix b.
- multiplyWithTransposed(DatanMatrix) - Method in class datan.DatanMatrix
-
Returns the matrix obtained by multipying this matrix from the right with the transposed of matrix b.
- multivariateNormal(DatanVector) - Static method in class datan.DatanRandom
-
returns a vector whose elements are distributed according to a multivariate normal distribution with mean aa
and covariance matrix c; the matrix c has to be set prior to using this method
by the method setCovarianceMatrixForMultivariateNormal(DatanMatrix c).
- S1Anova - Class in solutions
-
Performing an analysis of variance with crossed classification on simulated data
- S1Anova() - Constructor for class solutions.S1Anova
-
- S1Distrib - Class in solutions
-
Convolution of uniform distributions
- S1Distrib() - Constructor for class solutions.S1Distrib
-
- S1Lsq - Class in solutions
-
Data corresponding to 2nd degree polynomial fitted by 1st degree
- S1Lsq() - Constructor for class solutions.S1Lsq
-
- S1MaxLike - Class in solutions
-
Maximum-likelihood estimate of mean life from few decays
- S1MaxLike() - Constructor for class solutions.S1MaxLike
-
- S1Min - Class in solutions
-
Use of various minimization methods; first approximation found by Monte-Carlo method
- S1Min() - Constructor for class solutions.S1Min
-
- S1Random - Class in solutions
-
Creation of random numbers distributed according to a Breit-Wigner distribution
- S1Random() - Constructor for class solutions.S1Random
-
- S1Reg - Class in solutions
-
Polynomial regression on created data
- S1Reg() - Constructor for class solutions.S1Reg
-
- S1TimSer - Class in solutions
-
Creating data modelling a power law and performing a time series analysis on them
- S1TimSer() - Constructor for class solutions.S1TimSer
-
- S2Anova - Class in solutions
-
Performing an analysis of variance with nested classification on simulated data
- S2Anova() - Constructor for class solutions.S2Anova
-
- S2Distrib - Class in solutions
-
Convolution of uniform distribution with Gaussian
- S2Distrib() - Constructor for class solutions.S2Distrib
-
- S2Lsq - Class in solutions
-
Data fitted to power law (linear case)
- S2Lsq() - Constructor for class solutions.S2Lsq
-
- S2MaxLike - Class in solutions
-
Distribution of the sample correlation coefficient
- S2MaxLike() - Constructor for class solutions.S2MaxLike
-
- S2Min - Class in solutions
-
Fitting a Breit-Wigner function to small sample and determining errors of parameters by MinCov
- S2Min() - Constructor for class solutions.S2Min
-
- S2Random - Class in solutions
-
Creation of random numbers distributed according to a triangular distribution
- S2Random() - Constructor for class solutions.S2Random
-
- S2Reg - Class in solutions
-
Polynomial regression on created data.
- S2Reg() - Constructor for class solutions.S2Reg
-
- S2TimSer - Class in solutions
-
Creating data modelling a sine, a step, or a saw-toot function and performing a time series analysis on them
- S2TimSer() - Constructor for class solutions.S2TimSer
-
- S3Lsq - Class in solutions
-
Data fitted to power law (nonlinear case)
- S3Lsq() - Constructor for class solutions.S3Lsq
-
- S3Random - Class in solutions
-
Points fluctuating about a straight line, having errors of different sizes
- S3Random() - Constructor for class solutions.S3Random
-
- S4Lsq - Class in solutions
-
Data generated according to a Breit-Wigner function are fitted to Breit-Wigner or to Gaussian
- S4Lsq() - Constructor for class solutions.S4Lsq
-
- S5Lsq - Class in solutions
-
Data following a Breit-Wigner function are fitted to BW or Gaussian; asym. errors and confid. region shown
- S5Lsq() - Constructor for class solutions.S5Lsq
-
- S6Lsq - Class in solutions
-
Fit of a Breit-Wigner function to a histogram
- S6Lsq() - Constructor for class solutions.S6Lsq
-
- S7Lsq - Class in solutions
-
Fitting a circle to data points
- S7Lsq() - Constructor for class solutions.S7Lsq
-
- Sample - Class in datan
-
A class representing a sample.
- Sample(double[]) - Constructor for class datan.Sample
-
Creates a sample from array data.
- serialVersionUID - Static variable in class datangraphics.DatanGraphicsFrame
-
- serialVersionUID - Static variable in class examples.E1Min
-
- serialVersionUID - Static variable in class examples.FunctionsDemo
-
- serialVersionUID - Static variable in class solutions.S1Min
-
- setContentsAt(double, int) - Method in class datan.Histogram
-
Sets the contents of bin number i to the value in
- setCovarianceMatrixForMultivariateNormal(DatanMatrix) - Static method in class datan.DatanRandom
-
sets the covariance matrix of a multivariate normal distribution for
the subsequent use in the method multivariateNormal(DatanVector aa).
- setElement(int, int, double) - Method in class datan.DatanMatrix
-
sets element (i,j) ti in.
- setElement(int, double) - Method in class datan.DatanVector
-
Sets element i to in.
- setEnabled(boolean) - Method in class datan.AuxJNumberInput
-
enables or disables input.
- setEnabled(boolean) - Method in class datan.AuxJRButtonGroup
-
enables or disables all buttons, depending on boolean argument.
- setEnabled(int, boolean) - Method in class datan.AuxJRButtonGroup
-
enables or disables the button referenced by index, depending on boolean argument.
- setIsInteger(boolean) - Method in class datan.AuxJNumberInput
-
sets a property; if isInteger == true, only the input of integers is permissable.
- setMaximum(double) - Method in class datan.AuxJNumberInput
-
sets maximum permissible value.
- setMinimum(double) - Method in class datan.AuxJNumberInput
-
sets minmum permissible value.
- setNumberInTextField(double) - Method in class datan.AuxJNumberInput
-
places a number in the text field and checks it for validity.
- setProperties(boolean, boolean) - Method in class datan.AuxJNumberInput
-
sets properties; enables or disables input; if isInteger == true, only the input of integers is permissable.
- setProperties(boolean, boolean, double) - Method in class datan.AuxJNumberInput
-
sets properties; enables or disables input.
- setProperties(boolean, boolean, double, double) - Method in class datan.AuxJNumberInput
-
sets properties; enables or disables input; if isInteger == true, only the input of integers is permissable.
- setProperties(String, boolean) - Method in class datan.AuxJNumberInput
-
sets properties; input is enabled; if isInteger == true, only the input of integers is permissable.
- setProperties(String, boolean, double) - Method in class datan.AuxJNumberInput
-
sets properties; input is enabled; if isInteger == true, only the input of integers is permissable.
- setProperties(String, boolean, double, double) - Method in class datan.AuxJNumberInput
-
sets properties; input is enabled; if isInteger == true, only the input of integers is permissable.
- setSeedMlcg(int) - Static method in class datan.DatanRandom
-
sets seed for MLC generator.
- setSeedsEcuy(int[]) - Static method in class datan.DatanRandom
-
sets seeds for combined generator Ecuy; seeds has 2 elements.
- setSelectedIndex(int) - Method in class datan.AuxJRButtonGroup
-
sets the index of the selected radio button.
- setText(String) - Method in class datan.AuxJNumberInput
-
sets text for label.
- setText(String[]) - Method in class datan.AuxJRButtonGroup
-
replaces the text strings displayed to the right of the radio buttons.
- setToolTipText(String) - Method in class datan.AuxJNumberInput
-
sets tooltip text for label.
- setToolTipText(String[]) - Method in class datan.AuxJRButtonGroup
-
sets a tooltip text for each radio button.
- singularValueDecomposition(DatanMatrix) - Method in class datan.DatanMatrix
-
Returns solution matrix x of matrix equation a x = b (where a is this matix and b the matrix in the argument of the metod)
using singular value decomposition;
this call with only one argument should be used in unproblematic cases only, since it does not provide a check
of convergence of the method and further information.
- singularValueDecomposition(DatanVector, double[], double, int[], boolean[]) - Method in class datan.DatanMatrix
-
Returns solution vector x of matrix equation a x = b (where a is this matix) using singular value decomposition;
- singularValueDecomposition(DatanMatrix, DatanVector, double, int[], boolean[]) - Method in class datan.DatanMatrix
-
Returns solution matrix x of matrix equation a x = b (where a is this matix) using singular value decomposition;
- SmallSample - Class in datan
-
A class providing methods to compute confidence limits for small samples
- SmallSample() - Constructor for class datan.SmallSample
-
- solutions - package solutions
-
- standardNormal(int) - Static method in class datan.DatanRandom
-
returns an array containing n random numbers following the standard normal distribution;
internally the method uses the combined generator Ecuy.
- standardNormal(double) - Static method in class datan.StatFunct
-
returns probability density of standard normal distribution
- StatFunct - Class in datan
-
A class providing methods for computing statistical functions
- StatFunct() - Constructor for class datan.StatFunct
-
- student(double, int) - Static method in class datan.StatFunct
-
returns probability density of Student's distribution
- sub(DatanMatrix) - Method in class datan.DatanMatrix
-
Returns the difference between this matrix and the matrix b.
- sub(DatanVector) - Method in class datan.DatanVector
-
Returns original vector minus vector b.
- svm(DatanMatrix, DatanVector, double, DatanVector, DatanVector, double) - Method in class datan.DatanMatrix
-
Performs singular value analysis and application of Marquardt method.